From damian at man.poznan.pl Sat Jul 1 15:15:46 2017 From: damian at man.poznan.pl (Damian Kaliszan) Date: Sat, 01 Jul 2017 22:15:46 +0200 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> Message-ID: <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> Hi, So... - - with-openmp=0/1 configuration option seems to be useless?... In one of my previous messages I wrote that, when openmp enabled, and OMP_NUM_THREADS set, I notice different timings for ksp solver. Strange....? Best, Damian W dniu 1 lip 2017, 00:50, o 00:50, u?ytkownik Barry Smith napisa?: > >The current version of PETSc does not use OpenMP, you are free to use >OpenMP in your portions of the code of course. If you want PETSc using >OpenMP you have to use the old, unsupported version of PETSc. We never >found any benefit to using OpenMP. > > Barry > >> On Jun 30, 2017, at 5:40 PM, Danyang Su wrote: >> >> Dear All, >> >> I recalled there was OpenMP available for PETSc for the old >development version. When google "petsc hybrid mpi openmp", there >returned some papers about this feature. My code was first parallelized >using OpenMP and then redeveloped using PETSc, with OpenMP kept but not >used together with MPI. Before retesting the code using hybrid >mpi-openmp, I picked one PETSc example ex10 by adding >"omp_set_num_threads(max_threads);" under PetscInitialize. >> >> The PETSc is the current development version configured as follows >> >> --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --with-debugging=0 >--CFLAGS=-fopenmp --CXXFLAGS=-fopenmp --FFLAGS=-fopenmp COPTFLAGS="-O3 >-march=native -mtune=native" CXXOPTFLAGS="-O3 -march=native >-mtune=native" FOPTFLAGS="-O3 -march=native -mtune=native" >--with-large-file-io=1 --download-cmake=yes --download-mumps >--download-scalapack --download-parmetis --download-metis >--download-ptscotch --download-fblaslapack --download-mpich >--download-hypre --download-superlu_dist --download-hdf5=yes >--with-openmp --with-threadcomm --with-pthreadclasses >--with-openmpclasses >> >> The code can be successfully compiled. However, when I run the code >with OpenMP, it does not work, the time shows no change in performance >if 1 or 2 threads per processor is used. Also, the CPU/Threads usage >indicates that no thread is used. >> >> I just wonder if OpenMP is still available in the latest version, >though it is not recommended to use. >> >> mpiexec -n 2 ./ex10 -f0 mat_rhs_pc_nonzero/a_react_in_2.bin -rhs >mat_rhs_pc_nonzero/b_react_in_2.bin -ksp_rtol 1.0e-20 -ksp_monitor >-ksp_error_if_not_converged -sub_pc_factor_shift_type nonzero -mat_view >ascii::ascii_info -log_view -max_threads 1 -threadcomm_type openmp >-threadcomm_nthreads 1 >> >> KSPSolve 1 1.0 8.9934e-01 1.0 1.03e+09 1.0 7.8e+01 >3.6e+04 7.8e+01 69 97 89 6 76 89 97 98 98 96 2290 >> PCSetUp 2 1.0 8.9590e-02 1.0 2.91e+07 1.0 0.0e+00 >0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 648 >> PCSetUpOnBlocks 2 1.0 8.9465e-02 1.0 2.91e+07 1.0 0.0e+00 >0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 649 >> PCApply 40 1.0 3.1993e-01 1.0 2.70e+08 1.0 0.0e+00 >0.0e+00 0.0e+00 24 25 0 0 0 32 25 0 0 0 1686 >> >> mpiexec -n 2 ./ex10 -f0 mat_rhs_pc_nonzero/a_react_in_2.bin -rhs >mat_rhs_pc_nonzero/b_react_in_2.bin -ksp_rtol 1.0e-20 -ksp_monitor >-ksp_error_if_not_converged -sub_pc_factor_shift_type nonzero -mat_view >ascii::ascii_info -log_view -max_threads 2 -threadcomm_type openmp >-threadcomm_nthreads 2 >> >> KSPSolve 1 1.0 8.9701e-01 1.0 1.03e+09 1.0 7.8e+01 >3.6e+04 7.8e+01 69 97 89 6 76 89 97 98 98 96 2296 >> PCSetUp 2 1.0 8.7635e-02 1.0 2.91e+07 1.0 0.0e+00 >0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 663 >> PCSetUpOnBlocks 2 1.0 8.7511e-02 1.0 2.91e+07 1.0 0.0e+00 >0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 664 >> PCApply 40 1.0 3.1878e-01 1.0 2.70e+08 1.0 0.0e+00 >0.0e+00 0.0e+00 24 25 0 0 0 32 25 0 0 0 1692 >> >> Thanks and regards, >> >> Danyang >> >> >> -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sat Jul 1 15:23:19 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sat, 1 Jul 2017 15:23:19 -0500 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> Message-ID: > On Jul 1, 2017, at 3:15 PM, Damian Kaliszan wrote: > > Hi, > So... - - with-openmp=0/1 configuration option seems to be useless?... It merely enables the compiler flags for compiling with OpenMP; for example if your code has OpenMP in it. > In one of my previous messages I wrote that, when openmp enabled, and OMP_NUM_THREADS set, I notice different timings for ksp solver. Strange....? For the PETSc part yes number of threads shouldn't matter since PETSc would only use 1. > > > Best, > Damian > W dniu 1 lip 2017, o 00:50, u?ytkownik Barry Smith napisa?: > > The current version of PETSc does not use OpenMP, you are free to use OpenMP in your portions of the code of course. If you want PETSc using OpenMP you have to use the old, unsupported version of PETSc. We never found any benefit to using OpenMP. > > Barry > > On Jun 30, 2017, at 5:40 PM, Danyang Su wrote: > > Dear All, > > I recalled there was OpenMP available for PETSc for the old development version. When google "petsc hybrid mpi openmp", there returned some papers about this feature. My code was first parallelized using OpenMP and then redeveloped using PETSc, with OpenMP kept but not used together with MPI. Before retesting the code using hybrid mpi-openmp, I picked one PETSc example ex10 by adding "omp_set_num_threads(max_threads);" under PetscInitialize. > > The PETSc is the current development version configured as follows > > --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --with-debugging=0 --CFLAGS=-fopenmp --CXXFLAGS=-fopenmp --FFLAGS=-fopenmp COPTFLAGS="-O3 -march=native -mtune=native" CXXOPTFLAGS="-O3 -march=native -mtune=native" FOPTFLAGS="-O3 -march=native -mtune=native" --with-large-file-io=1 --download-cmake=yes --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes --with-openmp --with-threadcomm --with-pthreadclasses --with-openmpclasses > > The code can be successfully compiled. However, when I run the code with OpenMP, it does not work, the time shows no change in performance if 1 or 2 threads per processor is used. Also, the CPU/Threads usage indicates that no thread is used. > > I just wonder if OpenMP is still available in the latest version, though it is not recommended to use. > > mpiexec -n 2 ./ex10 -f0 mat_rhs_pc_nonzero/a_react_in_2.bin -rhs mat_rhs_pc_nonzero/b_react_in_2.bin -ksp_rtol 1.0e-20 -ksp_monitor -ksp_error_if_not_converged -sub_pc_factor_shift_type nonzero -mat_view ascii::ascii_info -log_view -max_threads 1 -threadcomm_type openmp -threadcomm_nthreads 1 > > KSPSolve 1 1.0 8.9934e-01 1.0 1.03e+09 1.0 7.8e+01 3.6e+04 7.8e+01 69 97 89 6 76 89 97 98 98 96 2290 > PCSetUp 2 1.0 8.9590e-02 1.0 2.91e+07 1.0 0.0e+00 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 648 > PCSetUpOnBlocks 2 1.0 8.9465e-02 1.0 2.91e+07 1.0 0.0e+00 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 649 > PCApply 40 1.0 3.1993e-01 1.0 2.70e+08 1.0 0.0e+00 0.0e+00 0.0e+00 24 25 0 0 0 32 25 0 0 0 1686 > > mpiexec -n 2 ./ex10 -f0 mat_rhs_pc_nonzero/a_react_in_2.bin -rhs mat_rhs_pc_nonzero/b_react_in_2.bin -ksp_rtol 1.0e-20 -ksp_monitor -ksp_error_if_not_converged -sub_pc_factor_shift_type nonzero -mat_view ascii::ascii_info -log_view -max_threads 2 -threadcomm_type openmp -threadcomm_nthreads 2 > > KSPSolve 1 1.0 8.9701e-01 1.0 1.03e+09 1.0 7.8e+01 3.6e+04 7.8e+01 69 97 89 6 76 89 97 98 98 96 2296 > PCSetUp 2 1.0 8.7635e-02 1.0 2.91e+07 1.0 0.0e+00 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 663 > PCSetUpOnBlocks 2 1.0 8.7511e-02 1.0 2.91e+07 1.0 0.0e+00 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 664 > PCApply 40 1.0 3.1878e-01 1.0 2.70e+08 1.0 0.0e+00 0.0e+00 0.0e+00 24 25 0 0 0 32 25 0 0 0 1692 > > Thanks and regards, > > Danyang > > > > From damian at man.poznan.pl Mon Jul 3 04:18:44 2017 From: damian at man.poznan.pl (Damian Kaliszan) Date: Mon, 3 Jul 2017 11:18:44 +0200 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> Message-ID: <323017251.20170703111844@man.poznan.pl> Hi, OK. So this is clear now. Maybe you will be able to help the answer the question I raised some time ago, why, when submitting a slurm job and setting different number of --cpus-per-task, the execution times of ksp solver (gmres type) vary when max number of iterations set to 100.000 and ksp, when finished, returns ksp.getIterationNumber() (in petsc4py) equal to 900 (for some cases) and 100.000 for other. It looks like number of cpus per task influence the number of steps the solver solves the equation. Is it possible at all? Best, Damian W li?cie datowanym 1 lipca 2017 (22:23:19) napisano: >> On Jul 1, 2017, at 3:15 PM, Damian Kaliszan wrote: >> >> Hi, >> So... - - with-openmp=0/1 configuration option seems to be useless?... > ? ?It merely enables the compiler flags for compiling with OpenMP; > for example if your code has OpenMP in it. >> In one of my previous messages I wrote that, when openmp enabled, and OMP_NUM_THREADS set, I notice different timings for ksp solver. Strange....? > ? ?For the PETSc part yes number of threads shouldn't matter since PETSc would only use 1. >> >> >> Best, >> Damian >> W dniu 1 lip 2017, o 00:50, u?ytkownik Barry Smith napisa?: >> >> ? The current version of PETSc does not use OpenMP, you are free to use OpenMP in your portions of the code of course. If you want PETSc using OpenMP you have to use the old, unsupported version of PETSc. We never found any benefit to using OpenMP. >> >> ? ?Barry >> >> ?On Jun 30, 2017, at 5:40 PM, Danyang Su wrote: >> ? >> ?Dear All, >> ? >> ?I recalled there was OpenMP available for PETSc for the old development version. When google "petsc hybrid mpi openmp", there returned some papers about this feature. My code was first parallelized using OpenMP and then redeveloped using PETSc, with OpenMP kept but not used together with MPI. Before retesting the code using hybrid mpi-openmp, I picked one PETSc example ex10 by adding "omp_set_num_threads(max_threads);" under PetscInitialize. >> ? >> ?The PETSc is the current development version configured as follows >> ? >> ?--with-cc=gcc --with-cxx=g++ --with-fc=gfortran --with-debugging=0 --CFLAGS=-fopenmp --CXXFLAGS=-fopenmp --FFLAGS=-fopenmp COPTFLAGS="-O3 -march=native -mtune=native" CXXOPTFLAGS="-O3 -march=native -mtune=native" FOPTFLAGS="-O3 -march=native -mtune=native" --with-large-file-io=1 --download-cmake=yes --download-mumps --download-scalapack --download-parmetis --download-metis --download-ptscotch --download-fblaslapack --download-mpich --download-hypre --download-superlu_dist --download-hdf5=yes --with-openmp --with-threadcomm --with-pthreadclasses --with-openmpclasses >> ? >> ?The code can be successfully compiled. However, when I run the code with OpenMP, it does not work, the time shows no change in performance if 1 or 2 threads per processor is used. Also, the CPU/Threads usage indicates that no thread is used. >> ? >> ?I just wonder if OpenMP is still available in the latest version, though it is not recommended to use. >> ? >> ?mpiexec -n 2 ./ex10 -f0 mat_rhs_pc_nonzero/a_react_in_2.bin -rhs mat_rhs_pc_nonzero/b_react_in_2.bin -ksp_rtol 1.0e-20 -ksp_monitor -ksp_error_if_not_converged -sub_pc_factor_shift_type nonzero -mat_view ascii::ascii_info -log_view -max_threads 1 -threadcomm_type openmp -threadcomm_nthreads 1 >> ? >> ?KSPSolve ? ? ? ? ? ? ? 1 1.0 8.9934e-01 1.0 1.03e+09 1.0 7.8e+01 3.6e+04 7.8e+01 69 97 89 ?6 76 ?89 97 98 98 96 ?2290 >> ?PCSetUp ? ? ? ? ? ? ? ?2 1.0 8.9590e-02 1.0 2.91e+07 1.0 0.0e+00 0.0e+00 0.0e+00 ?7 ?3 ?0 ?0 ?0 ? 9 ?3 ?0 ?0 ?0 ? 648 >> ?PCSetUpOnBlocks ? ? ? ?2 1.0 8.9465e-02 1.0 2.91e+07 1.0 0.0e+00 0.0e+00 0.0e+00 ?7 ?3 ?0 ?0 ?0 ? 9 ?3 ?0 ?0 ?0 ? 649 >> ?PCApply ? ? ? ? ? ? ? 40 1.0 3.1993e-01 1.0 2.70e+08 1.0 0.0e+00 0.0e+00 0.0e+00 24 25 ?0 ?0 ?0 ?32 25 ?0 ?0 ?0 ?1686 >> ? >> ?mpiexec -n 2 ./ex10 -f0 mat_rhs_pc_nonzero/a_react_in_2.bin -rhs mat_rhs_pc_nonzero/b_react_in_2.bin -ksp_rtol 1.0e-20 -ksp_monitor -ksp_error_if_not_converged -sub_pc_factor_shift_type nonzero -mat_view ascii::ascii_info -log_view -max_threads 2 -threadcomm_type openmp -threadcomm_nthreads 2 >> ? >> ?KSPSolve ? ? ? ? ? ? ? 1 1.0 8.9701e-01 1.0 1.03e+09 1.0 7.8e+01 3.6e+04 7.8e+01 69 97 89 ?6 76 ?89 97 98 98 96 ?2296 >> ?PCSetUp ? ? ? ? ? ? ? ?2 1.0 8.7635e-02 1.0 2.91e+07 1.0 0.0e+00 0.0e+00 0.0e+00 ?7 ?3 ?0 ?0 ?0 ? 9 ?3 ?0 ?0 ?0 ? 663 >> ?PCSetUpOnBlocks ? ? ? ?2 1.0 8.7511e-02 1.0 2.91e+07 1.0 0.0e+00 0.0e+00 0.0e+00 ?7 ?3 ?0 ?0 ?0 ? 9 ?3 ?0 ?0 ?0 ? 664 >> ?PCApply ? ? ? ? ? ? ? 40 1.0 3.1878e-01 1.0 2.70e+08 1.0 0.0e+00 0.0e+00 0.0e+00 24 25 ?0 ?0 ?0 ?32 25 ?0 ?0 ?0 ?1692 >> ? >> ?Thanks and regards, >> ? >> ?Danyang >> ? >> ? >> ? >> ------------------------------------------------------- Damian Kaliszan Poznan Supercomputing and Networking Center HPC and Data Centres Technologies ul. Jana Paw?a II 10 61-139 Poznan POLAND phone (+48 61) 858 5109 e-mail damian at man.poznan.pl www - http://www.man.poznan.pl/ ------------------------------------------------------- From knepley at gmail.com Mon Jul 3 08:14:10 2017 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 3 Jul 2017 08:14:10 -0500 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <323017251.20170703111844@man.poznan.pl> References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> <323017251.20170703111844@man.poznan.pl> Message-ID: On Mon, Jul 3, 2017 at 4:18 AM, Damian Kaliszan wrote: > Hi, > > OK. So this is clear now. > Maybe you will be able to help the answer the question I raised > some time ago, why, when > submitting a slurm job and setting different number of > --cpus-per-task, the execution times of ksp solver > (gmres type) vary when max number of iterations set to 100.000 > and ksp, when finished, returns ksp.getIterationNumber() (in petsc4py) > equal to 900 (for some cases) and 100.000 for other. > It looks like number of cpus per task influence the number of steps > the solver solves the equation. Is it possible at all? > If you have one solver executing on the whole communicator, PETSC_COMM_WORLD, all processes will report the same number of iterates. If you have independent, serial solvers on each process, PETSC_COMM_SELF, they can report different numbers of iterates depending on the convergence criteria. Matt > Best, > Damian > > W li?cie datowanym 1 lipca 2017 (22:23:19) napisano: > > > >> On Jul 1, 2017, at 3:15 PM, Damian Kaliszan > wrote: > >> > >> Hi, > >> So... - - with-openmp=0/1 configuration option seems to be useless?... > > > It merely enables the compiler flags for compiling with OpenMP; > > for example if your code has OpenMP in it. > > >> In one of my previous messages I wrote that, when openmp enabled, and > OMP_NUM_THREADS set, I notice different timings for ksp solver. Strange....? > > > For the PETSc part yes number of threads shouldn't matter since PETSc > would only use 1. > >> > >> > >> Best, > >> Damian > >> W dniu 1 lip 2017, o 00:50, u?ytkownik Barry Smith > napisa?: > >> > >> The current version of PETSc does not use OpenMP, you are free to use > OpenMP in your portions of the code of course. If you want PETSc using > OpenMP you have to use the old, unsupported version of PETSc. We never > found any benefit to using OpenMP. > >> > >> Barry > >> > >> On Jun 30, 2017, at 5:40 PM, Danyang Su wrote: > >> > >> Dear All, > >> > >> I recalled there was OpenMP available for PETSc for the old > development version. When google "petsc hybrid mpi openmp", there returned > some papers about this feature. My code was first parallelized using OpenMP > and then redeveloped using PETSc, with OpenMP kept but not used together > with MPI. Before retesting the code using hybrid mpi-openmp, I picked one > PETSc example ex10 by adding "omp_set_num_threads(max_threads);" under > PetscInitialize. > >> > >> The PETSc is the current development version configured as follows > >> > >> --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --with-debugging=0 > --CFLAGS=-fopenmp --CXXFLAGS=-fopenmp --FFLAGS=-fopenmp COPTFLAGS="-O3 > -march=native -mtune=native" CXXOPTFLAGS="-O3 -march=native -mtune=native" > FOPTFLAGS="-O3 -march=native -mtune=native" --with-large-file-io=1 > --download-cmake=yes --download-mumps --download-scalapack > --download-parmetis --download-metis --download-ptscotch > --download-fblaslapack --download-mpich --download-hypre > --download-superlu_dist --download-hdf5=yes --with-openmp --with-threadcomm > --with-pthreadclasses --with-openmpclasses > >> > >> The code can be successfully compiled. However, when I run the code > with OpenMP, it does not work, the time shows no change in performance if 1 > or 2 threads per processor is used. Also, the CPU/Threads usage indicates > that no thread is used. > >> > >> I just wonder if OpenMP is still available in the latest version, > though it is not recommended to use. > >> > >> mpiexec -n 2 ./ex10 -f0 mat_rhs_pc_nonzero/a_react_in_2.bin -rhs > mat_rhs_pc_nonzero/b_react_in_2.bin -ksp_rtol 1.0e-20 -ksp_monitor > -ksp_error_if_not_converged -sub_pc_factor_shift_type nonzero -mat_view > ascii::ascii_info -log_view -max_threads 1 -threadcomm_type openmp > -threadcomm_nthreads 1 > >> > >> KSPSolve 1 1.0 8.9934e-01 1.0 1.03e+09 1.0 7.8e+01 > 3.6e+04 7.8e+01 69 97 89 6 76 89 97 98 98 96 2290 > >> PCSetUp 2 1.0 8.9590e-02 1.0 2.91e+07 1.0 0.0e+00 > 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 648 > >> PCSetUpOnBlocks 2 1.0 8.9465e-02 1.0 2.91e+07 1.0 0.0e+00 > 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 649 > >> PCApply 40 1.0 3.1993e-01 1.0 2.70e+08 1.0 0.0e+00 > 0.0e+00 0.0e+00 24 25 0 0 0 32 25 0 0 0 1686 > >> > >> mpiexec -n 2 ./ex10 -f0 mat_rhs_pc_nonzero/a_react_in_2.bin -rhs > mat_rhs_pc_nonzero/b_react_in_2.bin -ksp_rtol 1.0e-20 -ksp_monitor > -ksp_error_if_not_converged -sub_pc_factor_shift_type nonzero -mat_view > ascii::ascii_info -log_view -max_threads 2 -threadcomm_type openmp > -threadcomm_nthreads 2 > >> > >> KSPSolve 1 1.0 8.9701e-01 1.0 1.03e+09 1.0 7.8e+01 > 3.6e+04 7.8e+01 69 97 89 6 76 89 97 98 98 96 2296 > >> PCSetUp 2 1.0 8.7635e-02 1.0 2.91e+07 1.0 0.0e+00 > 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 663 > >> PCSetUpOnBlocks 2 1.0 8.7511e-02 1.0 2.91e+07 1.0 0.0e+00 > 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 664 > >> PCApply 40 1.0 3.1878e-01 1.0 2.70e+08 1.0 0.0e+00 > 0.0e+00 0.0e+00 24 25 0 0 0 32 25 0 0 0 1692 > >> > >> Thanks and regards, > >> > >> Danyang > >> > >> > >> > >> > > > > > ------------------------------------------------------- > Damian Kaliszan > > Poznan Supercomputing and Networking Center > HPC and Data Centres Technologies > ul. Jana Paw?a II 10 > 61-139 Poznan > POLAND > > phone (+48 61) 858 5109 > e-mail damian at man.poznan.pl > www - http://www.man.poznan.pl/ > ------------------------------------------------------- > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From damian at man.poznan.pl Mon Jul 3 08:47:37 2017 From: damian at man.poznan.pl (Damian Kaliszan) Date: Mon, 3 Jul 2017 15:47:37 +0200 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> <323017251.20170703111844@man.poznan.pl> Message-ID: <1946888301.20170703154737@man.poznan.pl> An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Jul 3 08:50:17 2017 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 3 Jul 2017 08:50:17 -0500 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <1946888301.20170703154737@man.poznan.pl> References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> <323017251.20170703111844@man.poznan.pl> <1946888301.20170703154737@man.poznan.pl> Message-ID: On Mon, Jul 3, 2017 at 8:47 AM, Damian Kaliszan wrote: > Hi, > I use MPI.COMM_WORLD as communicator because I use bcast to send around > some other info to all processes before reading in the matrices and running > solver. > (I can't call bcast on PETSc.COMM_WORLD). > 1) You can call Bcast on PETSC_COMM_WORLD 2) If you are using WORLD, the number of iterates will be the same on each process since iteration is collective. Thanks, Matt > Best, > Damian > > W li?cie datowanym 3 lipca 2017 (15:14:10) napisano: > > > On Mon, Jul 3, 2017 at 4:18 AM, Damian Kaliszan > wrote: > Hi, > > OK. So this is clear now. > Maybe you will be able to help the answer the question I raised > some time ago, why, when > submitting a slurm job and setting different number of > --cpus-per-task, the execution times of ksp solver > (gmres type) vary when max number of iterations set to 100.000 > and ksp, when finished, returns ksp.getIterationNumber() (in petsc4py) > equal to 900 (for some cases) and 100.000 for other. > It looks like number of cpus per task influence the number of steps > the solver solves the equation. Is it possible at all? > > If you have one solver executing on the whole communicator, > PETSC_COMM_WORLD, > all processes will report the same number of iterates. If you have > independent, serial > solvers on each process, PETSC_COMM_SELF, they can report different > numbers of iterates > depending on the convergence criteria. > > Matt > > Best, > Damian > > W li?cie datowanym 1 lipca 2017 (22:23:19) napisano: > > > >> On Jul 1, 2017, at 3:15 PM, Damian Kaliszan > wrote: > >> > >> Hi, > >> So... - - with-openmp=0/1 configuration option seems to be useless?... > > > It merely enables the compiler flags for compiling with OpenMP; > > for example if your code has OpenMP in it. > > >> In one of my previous messages I wrote that, when openmp enabled, and > OMP_NUM_THREADS set, I notice different timings for ksp solver. Strange....? > > > For the PETSc part yes number of threads shouldn't matter since PETSc > would only use 1. > >> > >> > >> Best, > >> Damian > >> W dniu 1 lip 2017, o 00:50, u?ytkownik Barry Smith > napisa?: > >> > >> The current version of PETSc does not use OpenMP, you are free to use > OpenMP in your portions of the code of course. If you want PETSc using > OpenMP you have to use the old, unsupported version of PETSc. We never > found any benefit to using OpenMP. > >> > >> Barry > >> > >> On Jun 30, 2017, at 5:40 PM, Danyang Su wrote: > >> > >> Dear All, > >> > >> I recalled there was OpenMP available for PETSc for the old > development version. When google "petsc hybrid mpi openmp", there returned > some papers about this feature. My code was first parallelized using OpenMP > and then redeveloped using PETSc, with OpenMP kept but not used together > with MPI. Before retesting the code using hybrid mpi-openmp, I picked one > PETSc example ex10 by adding "omp_set_num_threads(max_threads);" under > PetscInitialize. > >> > >> The PETSc is the current development version configured as follows > >> > >> --with-cc=gcc --with-cxx=g++ --with-fc=gfortran --with-debugging=0 > --CFLAGS=-fopenmp --CXXFLAGS=-fopenmp --FFLAGS=-fopenmp COPTFLAGS="-O3 > -march=native -mtune=native" CXXOPTFLAGS="-O3 -march=native -mtune=native" > FOPTFLAGS="-O3 -march=native -mtune=native" --with-large-file-io=1 > --download-cmake=yes --download-mumps --download-scalapack > --download-parmetis --download-metis --download-ptscotch > --download-fblaslapack --download-mpich --download-hypre > --download-superlu_dist --download-hdf5=yes --with-openmp --with-threadcomm > --with-pthreadclasses --with-openmpclasses > >> > >> The code can be successfully compiled. However, when I run the code > with OpenMP, it does not work, the time shows no change in performance if 1 > or 2 threads per processor is used. Also, the CPU/Threads usage indicates > that no thread is used. > >> > >> I just wonder if OpenMP is still available in the latest version, > though it is not recommended to use. > >> > >> mpiexec -n 2 ./ex10 -f0 mat_rhs_pc_nonzero/a_react_in_2.bin -rhs > mat_rhs_pc_nonzero/b_react_in_2.bin -ksp_rtol 1.0e-20 -ksp_monitor > -ksp_error_if_not_converged -sub_pc_factor_shift_type nonzero -mat_view > ascii::ascii_info -log_view -max_threads 1 -threadcomm_type openmp > -threadcomm_nthreads 1 > >> > >> KSPSolve 1 1.0 8.9934e-01 1.0 1.03e+09 1.0 7.8e+01 > 3.6e+04 7.8e+01 69 97 89 6 76 89 97 98 98 96 2290 > >> PCSetUp 2 1.0 8.9590e-02 1.0 2.91e+07 1.0 0.0e+00 > 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 648 > >> PCSetUpOnBlocks 2 1.0 8.9465e-02 1.0 2.91e+07 1.0 0.0e+00 > 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 649 > >> PCApply 40 1.0 3.1993e-01 1.0 2.70e+08 1.0 0.0e+00 > 0.0e+00 0.0e+00 24 25 0 0 0 32 25 0 0 0 1686 > >> > >> mpiexec -n 2 ./ex10 -f0 mat_rhs_pc_nonzero/a_react_in_2.bin -rhs > mat_rhs_pc_nonzero/b_react_in_2.bin -ksp_rtol 1.0e-20 -ksp_monitor > -ksp_error_if_not_converged -sub_pc_factor_shift_type nonzero -mat_view > ascii::ascii_info -log_view -max_threads 2 -threadcomm_type openmp > -threadcomm_nthreads 2 > >> > >> KSPSolve 1 1.0 8.9701e-01 1.0 1.03e+09 1.0 7.8e+01 > 3.6e+04 7.8e+01 69 97 89 6 76 89 97 98 98 96 2296 > >> PCSetUp 2 1.0 8.7635e-02 1.0 2.91e+07 1.0 0.0e+00 > 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 663 > >> PCSetUpOnBlocks 2 1.0 8.7511e-02 1.0 2.91e+07 1.0 0.0e+00 > 0.0e+00 0.0e+00 7 3 0 0 0 9 3 0 0 0 664 > >> PCApply 40 1.0 3.1878e-01 1.0 2.70e+08 1.0 0.0e+00 > 0.0e+00 0.0e+00 24 25 0 0 0 32 25 0 0 0 1692 > >> > >> Thanks and regards, > >> > >> Danyang > >> > >> > >> > >> > > > > > - > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From damian at man.poznan.pl Mon Jul 3 09:10:15 2017 From: damian at man.poznan.pl (Damian Kaliszan) Date: Mon, 3 Jul 2017 16:10:15 +0200 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> <323017251.20170703111844@man.poznan.pl> <1946888301.20170703154737@man.poznan.pl> Message-ID: <1724293596.20170703161015@man.poznan.pl> An HTML attachment was scrubbed... URL: From damian at man.poznan.pl Mon Jul 3 09:23:17 2017 From: damian at man.poznan.pl (Damian Kaliszan) Date: Mon, 3 Jul 2017 16:23:17 +0200 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> <323017251.20170703111844@man.poznan.pl> <1946888301.20170703154737@man.poznan.pl> Message-ID: <1734368881.20170703162317@man.poznan.pl> Hi, >> 1) You can call Bcast on PETSC_COMM_WORLD To be honest I can't find Bcast method in petsc4py.PETSc.Comm (I'm using petsc4py) >> 2) If you are using WORLD, the number of iterates will be the same on each process since iteration is collective. Yes, this is how it should be. But what I noticed is that for different --cpus-per-task numbers in slurm script I get different number of solver iterations which is in turn related to timings. The imparity is huge. For example for some configurations where --cpus-per-task=1 I receive 900 iterations and for --cpus-per-task=2 I receive valid number of 100.000 which is set as max iter number set when setting solver tolerances. Best, Damian From lawrence.mitchell at imperial.ac.uk Mon Jul 3 09:25:39 2017 From: lawrence.mitchell at imperial.ac.uk (Lawrence Mitchell) Date: Mon, 3 Jul 2017 15:25:39 +0100 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <1734368881.20170703162317@man.poznan.pl> References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> <323017251.20170703111844@man.poznan.pl> <1946888301.20170703154737@man.poznan.pl> <1734368881.20170703162317@man.poznan.pl> Message-ID: <552149B0-CDF2-4007-88AC-3C6EC9ABF121@imperial.ac.uk> > On 3 Jul 2017, at 15:23, Damian Kaliszan wrote: > > Hi, > > >>> 1) You can call Bcast on PETSC_COMM_WORLD > > To be honest I can't find Bcast method in petsc4py.PETSc.Comm (I'm > using petsc4py) Use PETSc.COMM_WORLD.tompi4py() to get an mpi4py communicator that supports all the things you want. Lawrence From knepley at gmail.com Mon Jul 3 09:29:15 2017 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 3 Jul 2017 09:29:15 -0500 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <1734368881.20170703162317@man.poznan.pl> References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> <323017251.20170703111844@man.poznan.pl> <1946888301.20170703154737@man.poznan.pl> <1734368881.20170703162317@man.poznan.pl> Message-ID: On Mon, Jul 3, 2017 at 9:23 AM, Damian Kaliszan wrote: > Hi, > > > >> 1) You can call Bcast on PETSC_COMM_WORLD > > To be honest I can't find Bcast method in petsc4py.PETSc.Comm (I'm > using petsc4py) > > >> 2) If you are using WORLD, the number of iterates will be the same on > each process since iteration is collective. > > Yes, this is how it should be. But what I noticed is that for > different --cpus-per-task numbers in slurm script I get different > number of solver iterations which is in turn related to timings. The > imparity is huge. For example for some configurations where > --cpus-per-task=1 I receive 900 > iterations and for --cpus-per-task=2 I receive valid number of 100.000 > which is set as max > iter number set when setting solver tolerances. > I am trying to understand what you are saying. You mean that you make 2 different runs and get a different number of iterates with a KSP? In order to answer questions about convergence, we need to see the output of -ksp_view -ksp_monitor_true_residual -ksp_converged_reason for all cases. Thanks, Matt > Best, > Damian > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From jason.lefley at aclectic.com Mon Jul 3 10:06:58 2017 From: jason.lefley at aclectic.com (Jason Lefley) Date: Mon, 3 Jul 2017 11:06:58 -0400 Subject: [petsc-users] Issue using multi-grid as a pre-conditioner with KSP for a Poisson problem In-Reply-To: References: <89C033B5-529D-4B36-B4AF-2EC35CA2CCAB@aclectic.com> <4D5B3921-810B-49AD-97E9-8BF1DECBF655@aclectic.com> <063A8337-A2DC-4869-8E55-451F0F6F592C@aclectic.com> Message-ID: > On Jun 26, 2017, at 7:52 PM, Matthew Knepley wrote: > > On Mon, Jun 26, 2017 at 8:37 PM, Jason Lefley > wrote: >> Okay, when you say a Poisson problem, I assumed you meant >> >> div grad phi = f >> >> However, now it appears that you have >> >> div D grad phi = f >> >> Is this true? It would explain your results. Your coarse operator is inaccurate. AMG makes the coarse operator directly >> from the matrix, so it incorporates coefficient variation. Galerkin projection makes the coarse operator using R A P >> from your original operator A, and this is accurate enough to get good convergence. So your coefficient representation >> on the coarse levels is really bad. If you want to use GMG, you need to figure out how to represent the coefficient on >> coarser levels, which is sometimes called "renormalization". >> >> Matt > > I believe we are solving the first one. The discretized form we are using is equation 13 in this document: https://www.rsmas.miami.edu/users/miskandarani/Courses/MSC321/Projects/prjpoisson.pdf Would you clarify why you think we are solving the second equation? > > Something is wrong. The writeup is just showing the FD Laplacian. Can you take a look at SNES ex5, and let > me know how your problem differs from that one? There were use GMG and can converge is a few (5-6) iterates, > and if you use FMG you converge in 1 iterate. In fact, that is in my class notes on the CAAM 519 website. Its possible > that you have badly scaled boundary values, which can cause convergence to deteriorate. > > Thanks, > > Matt > I went through ex5 and some of the other Poisson/multigrid examples again and noticed that they arrange the coefficients in a particular way. Our original attempt (solver_test.c) and some related codes that solve similar problems use an arrangement like this: u(i-1,j,k) - 2u(i,j,k) + u(i+1,j,k) u(i,j-1,k) - 2u(i,j,k) + u(i,j+1,k) u(i,j,k-1) - 2u(i,j,k) + u(i,j,k+1) ---------------------------------------- + ---------------------------------------- + ---------------------------------------- = f dx^2 dy^2 dz^2 That results in the coefficient matrix containing -2 * (1/dx^2 + 1/dy^2 + 1/dz^2) on the diagonal and 1/dx^2, 1/dy^2 and 1/dz^2 on the off-diagonals. I?ve also looked at some codes that assume h = dx = dy = dz, multiply f by h^2 and then use -6 and 1 for the coefficients in the matrix. It looks like snes ex5, ksp ex32, and ksp ex34 rearrange the terms like this: dy dz (u(i-1,j,k) - 2u(i,j,k) + u(i+1,j,k)) dx dz (u(i,j-1,k) - 2u(i,j,k) + u(i,j+1,k)) dx dy (u(i,j,k-1) - 2u(i,j,k) + u(i,j,k+1)) --------------------------------------------------- + --------------------------------------------------- + --------------------------------------------------- = f dx dy dz dx dy dz I changed our code to use this approach and we observe much better convergence with the mg pre-conditioner. Is this renormalization? Can anyone explain why this change has such an impact on convergence with geometric multigrid as a pre-conditioner? It does not appear that the arrangement of coefficients affects convergence when using conjugate gradient without a pre-conditioner. Here?s output from some runs with the coefficients and right hand side modified as described above: $ mpirun -n 16 ./solver_test -da_grid_x 128 -da_grid_y 128 -da_grid_z 128 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 5 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 right hand side 2 norm: 0.000244141 right hand side infinity norm: 4.76406e-07 0 KSP preconditioned resid norm 3.578255383614e+00 true resid norm 2.441406250000e-04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.385321366208e-01 true resid norm 4.207234652404e-05 ||r(i)||/||b|| 1.723283313625e-01 2 KSP preconditioned resid norm 4.459925861922e-03 true resid norm 1.480495515589e-06 ||r(i)||/||b|| 6.064109631854e-03 3 KSP preconditioned resid norm 4.311025848794e-04 true resid norm 1.021041953365e-07 ||r(i)||/||b|| 4.182187840984e-04 4 KSP preconditioned resid norm 1.619865162873e-05 true resid norm 5.438265013849e-09 ||r(i)||/||b|| 2.227513349673e-05 Linear solve converged due to CONVERGED_RTOL iterations 4 KSP final norm of residual 5.43827e-09 Residual 2 norm 5.43827e-09 Residual infinity norm 6.25328e-11 $ mpirun -n 16 ./solver_test -da_grid_x 128 -da_grid_y 128 -da_grid_z 128 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 5 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 -pc_mg_type full 0 KSP preconditioned resid norm 3.459879233358e+00 true resid norm 2.441406250000e-04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.169574216505e-02 true resid norm 4.856676267753e-06 ||r(i)||/||b|| 1.989294599272e-02 2 KSP preconditioned resid norm 1.158728408668e-04 true resid norm 1.603345697667e-08 ||r(i)||/||b|| 6.567303977645e-05 3 KSP preconditioned resid norm 6.035498575583e-07 true resid norm 1.613378731540e-10 ||r(i)||/||b|| 6.608399284389e-07 Linear solve converged due to CONVERGED_RTOL iterations 3 KSP final norm of residual 1.61338e-10 Residual 2 norm 1.61338e-10 Residual infinity norm 1.95499e-12 $ mpirun -n 64 ./solver_test -da_grid_x 512 -da_grid_y 512 -da_grid_z 512 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 8 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 -pc_mg_type full -bc_type neumann right hand side 2 norm: 3.05176e-05 right hand side infinity norm: 7.45016e-09 0 KSP preconditioned resid norm 5.330711358065e+01 true resid norm 3.051757812500e-05 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 4.687628546610e-04 true resid norm 2.452752396888e-08 ||r(i)||/||b|| 8.037179054124e-04 Linear solve converged due to CONVERGED_RTOL iterations 1 KSP final norm of residual 2.45275e-08 Residual 2 norm 2.45275e-08 Residual infinity norm 8.41572e-10 -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Mon Jul 3 11:24:15 2017 From: knepley at gmail.com (Matthew Knepley) Date: Mon, 3 Jul 2017 11:24:15 -0500 Subject: [petsc-users] Issue using multi-grid as a pre-conditioner with KSP for a Poisson problem In-Reply-To: References: <89C033B5-529D-4B36-B4AF-2EC35CA2CCAB@aclectic.com> <4D5B3921-810B-49AD-97E9-8BF1DECBF655@aclectic.com> <063A8337-A2DC-4869-8E55-451F0F6F592C@aclectic.com> Message-ID: On Mon, Jul 3, 2017 at 10:06 AM, Jason Lefley wrote: > > On Jun 26, 2017, at 7:52 PM, Matthew Knepley wrote: > > On Mon, Jun 26, 2017 at 8:37 PM, Jason Lefley > wrote: > >> Okay, when you say a Poisson problem, I assumed you meant >> >> div grad phi = f >> >> However, now it appears that you have >> >> div D grad phi = f >> >> Is this true? It would explain your results. Your coarse operator is >> inaccurate. AMG makes the coarse operator directly >> from the matrix, so it incorporates coefficient variation. Galerkin >> projection makes the coarse operator using R A P >> from your original operator A, and this is accurate enough to get good >> convergence. So your coefficient representation >> on the coarse levels is really bad. If you want to use GMG, you need to >> figure out how to represent the coefficient on >> coarser levels, which is sometimes called "renormalization". >> >> Matt >> >> >> I believe we are solving the first one. The discretized form we are using >> is equation 13 in this document: https://www.rsmas.mi >> ami.edu/users/miskandarani/Courses/MSC321/Projects/prjpoisson.pdf Would >> you clarify why you think we are solving the second equation? >> > > Something is wrong. The writeup is just showing the FD Laplacian. Can you > take a look at SNES ex5, and let > me know how your problem differs from that one? There were use GMG and can > converge is a few (5-6) iterates, > and if you use FMG you converge in 1 iterate. In fact, that is in my class > notes on the CAAM 519 website. Its possible > that you have badly scaled boundary values, which can cause convergence to > deteriorate. > > Thanks, > > Matt > > > > I went through ex5 and some of the other Poisson/multigrid examples again > and noticed that they arrange the coefficients in a particular way. > > Our original attempt (solver_test.c) and some related codes that solve > similar problems use an arrangement like this: > > > u(i-1,j,k) - 2u(i,j,k) + u(i+1,j,k) u(i,j-1,k) - 2u(i,j,k) + > u(i,j+1,k) u(i,j,k-1) - 2u(i,j,k) + u(i,j,k+1) > ---------------------------------------- + > ---------------------------------------- + ---------------------------------------- > = f > dx^2 dy^2 > dz^2 > > That results in the coefficient matrix containing -2 * (1/dx^2 + 1/dy^2 + > 1/dz^2) on the diagonal and 1/dx^2, 1/dy^2 and 1/dz^2 on the off-diagonals. > I?ve also looked at some codes that assume h = dx = dy = dz, multiply f by > h^2 and then use -6 and 1 for the coefficients in the matrix. > > It looks like snes ex5, ksp ex32, and ksp ex34 rearrange the terms like > this: > > > dy dz (u(i-1,j,k) - 2u(i,j,k) + u(i+1,j,k)) dx dz > (u(i,j-1,k) - 2u(i,j,k) + u(i,j+1,k)) dx dy (u(i,j,k-1) - > 2u(i,j,k) + u(i,j,k+1)) > --------------------------------------------------- + > --------------------------------------------------- + > --------------------------------------------------- = f dx dy dz > dx > dy dz > > > I changed our code to use this approach and we observe much better > convergence with the mg pre-conditioner. Is this renormalization? > No, this is proper scaling of the boundary conditions I believe. Matt > Can anyone explain why this change has such an impact on convergence with > geometric multigrid as a pre-conditioner? It does not appear that the > arrangement of coefficients affects convergence when using conjugate > gradient without a pre-conditioner. Here?s output from some runs with the > coefficients and right hand side modified as described above: > > > $ mpirun -n 16 ./solver_test -da_grid_x 128 -da_grid_y 128 -da_grid_z 128 > -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 5 > -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale > -mg_levels_ksp_max_it 5 > right hand side 2 norm: 0.000244141 > right hand side infinity norm: 4.76406e-07 > 0 KSP preconditioned resid norm 3.578255383614e+00 true resid norm > 2.441406250000e-04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.385321366208e-01 true resid norm > 4.207234652404e-05 ||r(i)||/||b|| 1.723283313625e-01 > 2 KSP preconditioned resid norm 4.459925861922e-03 true resid norm > 1.480495515589e-06 ||r(i)||/||b|| 6.064109631854e-03 > 3 KSP preconditioned resid norm 4.311025848794e-04 true resid norm > 1.021041953365e-07 ||r(i)||/||b|| 4.182187840984e-04 > 4 KSP preconditioned resid norm 1.619865162873e-05 true resid norm > 5.438265013849e-09 ||r(i)||/||b|| 2.227513349673e-05 > Linear solve converged due to CONVERGED_RTOL iterations 4 > KSP final norm of residual 5.43827e-09 > Residual 2 norm 5.43827e-09 > Residual infinity norm 6.25328e-11 > > > $ mpirun -n 16 ./solver_test -da_grid_x 128 -da_grid_y 128 -da_grid_z 128 > -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 5 > -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale > -mg_levels_ksp_max_it 5 -pc_mg_type full > 0 KSP preconditioned resid norm 3.459879233358e+00 true resid norm > 2.441406250000e-04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.169574216505e-02 true resid norm > 4.856676267753e-06 ||r(i)||/||b|| 1.989294599272e-02 > 2 KSP preconditioned resid norm 1.158728408668e-04 true resid norm > 1.603345697667e-08 ||r(i)||/||b|| 6.567303977645e-05 > 3 KSP preconditioned resid norm 6.035498575583e-07 true resid norm > 1.613378731540e-10 ||r(i)||/||b|| 6.608399284389e-07 > Linear solve converged due to CONVERGED_RTOL iterations 3 > KSP final norm of residual 1.61338e-10 > Residual 2 norm 1.61338e-10 > Residual infinity norm 1.95499e-12 > > > $ mpirun -n 64 ./solver_test -da_grid_x 512 -da_grid_y 512 -da_grid_z 512 > -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 8 > -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale > -mg_levels_ksp_max_it 5 -pc_mg_type full -bc_type neumann > right hand side 2 norm: 3.05176e-05 > right hand side infinity norm: 7.45016e-09 > 0 KSP preconditioned resid norm 5.330711358065e+01 true resid norm > 3.051757812500e-05 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 4.687628546610e-04 true resid norm > 2.452752396888e-08 ||r(i)||/||b|| 8.037179054124e-04 > Linear solve converged due to CONVERGED_RTOL iterations 1 > KSP final norm of residual 2.45275e-08 > Residual 2 norm 2.45275e-08 > Residual infinity norm 8.41572e-10 > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Mon Jul 3 12:19:04 2017 From: jed at jedbrown.org (Jed Brown) Date: Mon, 03 Jul 2017 11:19:04 -0600 Subject: [petsc-users] Issue using multi-grid as a pre-conditioner with KSP for a Poisson problem In-Reply-To: References: <89C033B5-529D-4B36-B4AF-2EC35CA2CCAB@aclectic.com> <4D5B3921-810B-49AD-97E9-8BF1DECBF655@aclectic.com> <063A8337-A2DC-4869-8E55-451F0F6F592C@aclectic.com> Message-ID: <871spxigl3.fsf@jedbrown.org> Scaling by the volume element causes the rediscretized coarse grid problem to be scaled like a Galerkin coarse operator. This is done automatically when you use finite element methods. Jason Lefley writes: >> On Jun 26, 2017, at 7:52 PM, Matthew Knepley wrote: >> >> On Mon, Jun 26, 2017 at 8:37 PM, Jason Lefley > wrote: >>> Okay, when you say a Poisson problem, I assumed you meant >>> >>> div grad phi = f >>> >>> However, now it appears that you have >>> >>> div D grad phi = f >>> >>> Is this true? It would explain your results. Your coarse operator is inaccurate. AMG makes the coarse operator directly >>> from the matrix, so it incorporates coefficient variation. Galerkin projection makes the coarse operator using R A P >>> from your original operator A, and this is accurate enough to get good convergence. So your coefficient representation >>> on the coarse levels is really bad. If you want to use GMG, you need to figure out how to represent the coefficient on >>> coarser levels, which is sometimes called "renormalization". >>> >>> Matt >> >> I believe we are solving the first one. The discretized form we are using is equation 13 in this document: https://www.rsmas.miami.edu/users/miskandarani/Courses/MSC321/Projects/prjpoisson.pdf Would you clarify why you think we are solving the second equation? >> >> Something is wrong. The writeup is just showing the FD Laplacian. Can you take a look at SNES ex5, and let >> me know how your problem differs from that one? There were use GMG and can converge is a few (5-6) iterates, >> and if you use FMG you converge in 1 iterate. In fact, that is in my class notes on the CAAM 519 website. Its possible >> that you have badly scaled boundary values, which can cause convergence to deteriorate. >> >> Thanks, >> >> Matt >> > > I went through ex5 and some of the other Poisson/multigrid examples again and noticed that they arrange the coefficients in a particular way. > > Our original attempt (solver_test.c) and some related codes that solve similar problems use an arrangement like this: > > > u(i-1,j,k) - 2u(i,j,k) + u(i+1,j,k) u(i,j-1,k) - 2u(i,j,k) + u(i,j+1,k) u(i,j,k-1) - 2u(i,j,k) + u(i,j,k+1) > ---------------------------------------- + ---------------------------------------- + ---------------------------------------- = f > dx^2 dy^2 dz^2 > > That results in the coefficient matrix containing -2 * (1/dx^2 + 1/dy^2 + 1/dz^2) on the diagonal and 1/dx^2, 1/dy^2 and 1/dz^2 on the off-diagonals. I?ve also looked at some codes that assume h = dx = dy = dz, multiply f by h^2 and then use -6 and 1 for the coefficients in the matrix. > > It looks like snes ex5, ksp ex32, and ksp ex34 rearrange the terms like this: > > > dy dz (u(i-1,j,k) - 2u(i,j,k) + u(i+1,j,k)) dx dz (u(i,j-1,k) - 2u(i,j,k) + u(i,j+1,k)) dx dy (u(i,j,k-1) - 2u(i,j,k) + u(i,j,k+1)) > --------------------------------------------------- + --------------------------------------------------- + --------------------------------------------------- = f dx dy dz > dx dy dz > > > I changed our code to use this approach and we observe much better convergence with the mg pre-conditioner. Is this renormalization? Can anyone explain why this change has such an impact on convergence with geometric multigrid as a pre-conditioner? It does not appear that the arrangement of coefficients affects convergence when using conjugate gradient without a pre-conditioner. Here?s output from some runs with the coefficients and right hand side modified as described above: > > > $ mpirun -n 16 ./solver_test -da_grid_x 128 -da_grid_y 128 -da_grid_z 128 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 5 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 > right hand side 2 norm: 0.000244141 > right hand side infinity norm: 4.76406e-07 > 0 KSP preconditioned resid norm 3.578255383614e+00 true resid norm 2.441406250000e-04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.385321366208e-01 true resid norm 4.207234652404e-05 ||r(i)||/||b|| 1.723283313625e-01 > 2 KSP preconditioned resid norm 4.459925861922e-03 true resid norm 1.480495515589e-06 ||r(i)||/||b|| 6.064109631854e-03 > 3 KSP preconditioned resid norm 4.311025848794e-04 true resid norm 1.021041953365e-07 ||r(i)||/||b|| 4.182187840984e-04 > 4 KSP preconditioned resid norm 1.619865162873e-05 true resid norm 5.438265013849e-09 ||r(i)||/||b|| 2.227513349673e-05 > Linear solve converged due to CONVERGED_RTOL iterations 4 > KSP final norm of residual 5.43827e-09 > Residual 2 norm 5.43827e-09 > Residual infinity norm 6.25328e-11 > > > $ mpirun -n 16 ./solver_test -da_grid_x 128 -da_grid_y 128 -da_grid_z 128 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 5 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 -pc_mg_type full > 0 KSP preconditioned resid norm 3.459879233358e+00 true resid norm 2.441406250000e-04 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.169574216505e-02 true resid norm 4.856676267753e-06 ||r(i)||/||b|| 1.989294599272e-02 > 2 KSP preconditioned resid norm 1.158728408668e-04 true resid norm 1.603345697667e-08 ||r(i)||/||b|| 6.567303977645e-05 > 3 KSP preconditioned resid norm 6.035498575583e-07 true resid norm 1.613378731540e-10 ||r(i)||/||b|| 6.608399284389e-07 > Linear solve converged due to CONVERGED_RTOL iterations 3 > KSP final norm of residual 1.61338e-10 > Residual 2 norm 1.61338e-10 > Residual infinity norm 1.95499e-12 > > > $ mpirun -n 64 ./solver_test -da_grid_x 512 -da_grid_y 512 -da_grid_z 512 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 8 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 -pc_mg_type full -bc_type neumann > right hand side 2 norm: 3.05176e-05 > right hand side infinity norm: 7.45016e-09 > 0 KSP preconditioned resid norm 5.330711358065e+01 true resid norm 3.051757812500e-05 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 4.687628546610e-04 true resid norm 2.452752396888e-08 ||r(i)||/||b|| 8.037179054124e-04 > Linear solve converged due to CONVERGED_RTOL iterations 1 > KSP final norm of residual 2.45275e-08 > Residual 2 norm 2.45275e-08 > Residual infinity norm 8.41572e-10 -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From bsmith at mcs.anl.gov Mon Jul 3 15:21:09 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 3 Jul 2017 15:21:09 -0500 Subject: [petsc-users] Issue using multi-grid as a pre-conditioner with KSP for a Poisson problem In-Reply-To: <871spxigl3.fsf@jedbrown.org> References: <89C033B5-529D-4B36-B4AF-2EC35CA2CCAB@aclectic.com> <4D5B3921-810B-49AD-97E9-8BF1DECBF655@aclectic.com> <063A8337-A2DC-4869-8E55-451F0F6F592C@aclectic.com> <871spxigl3.fsf@jedbrown.org> Message-ID: > On Jul 3, 2017, at 12:19 PM, Jed Brown wrote: > > Scaling by the volume element causes the rediscretized coarse grid > problem to be scaled like a Galerkin coarse operator. This is done > automatically when you use finite element methods. Galerkin coarse grid operator means that P A_c^-1R projects the error onto the coarse grid space. If A_c has "the wrong scaling" then P A_c^-1R still projects the error but then scales the result incorrectly so the final correction computed is either much to large or to small. The option -pc_mg_galerkin computes A_c as R A P which automatically picks the right scaling. This is definitely not the concept of renormalization; that is much more complex and not related to Poisson problems. Barry > > Jason Lefley writes: > >>> On Jun 26, 2017, at 7:52 PM, Matthew Knepley wrote: >>> >>> On Mon, Jun 26, 2017 at 8:37 PM, Jason Lefley > wrote: >>>> Okay, when you say a Poisson problem, I assumed you meant >>>> >>>> div grad phi = f >>>> >>>> However, now it appears that you have >>>> >>>> div D grad phi = f >>>> >>>> Is this true? It would explain your results. Your coarse operator is inaccurate. AMG makes the coarse operator directly >>>> from the matrix, so it incorporates coefficient variation. Galerkin projection makes the coarse operator using R A P >>>> from your original operator A, and this is accurate enough to get good convergence. So your coefficient representation >>>> on the coarse levels is really bad. If you want to use GMG, you need to figure out how to represent the coefficient on >>>> coarser levels, which is sometimes called "renormalization". >>>> >>>> Matt >>> >>> I believe we are solving the first one. The discretized form we are using is equation 13 in this document: https://www.rsmas.miami.edu/users/miskandarani/Courses/MSC321/Projects/prjpoisson.pdf Would you clarify why you think we are solving the second equation? >>> >>> Something is wrong. The writeup is just showing the FD Laplacian. Can you take a look at SNES ex5, and let >>> me know how your problem differs from that one? There were use GMG and can converge is a few (5-6) iterates, >>> and if you use FMG you converge in 1 iterate. In fact, that is in my class notes on the CAAM 519 website. Its possible >>> that you have badly scaled boundary values, which can cause convergence to deteriorate. >>> >>> Thanks, >>> >>> Matt >>> >> >> I went through ex5 and some of the other Poisson/multigrid examples again and noticed that they arrange the coefficients in a particular way. >> >> Our original attempt (solver_test.c) and some related codes that solve similar problems use an arrangement like this: >> >> >> u(i-1,j,k) - 2u(i,j,k) + u(i+1,j,k) u(i,j-1,k) - 2u(i,j,k) + u(i,j+1,k) u(i,j,k-1) - 2u(i,j,k) + u(i,j,k+1) >> ---------------------------------------- + ---------------------------------------- + ---------------------------------------- = f >> dx^2 dy^2 dz^2 >> >> That results in the coefficient matrix containing -2 * (1/dx^2 + 1/dy^2 + 1/dz^2) on the diagonal and 1/dx^2, 1/dy^2 and 1/dz^2 on the off-diagonals. I?ve also looked at some codes that assume h = dx = dy = dz, multiply f by h^2 and then use -6 and 1 for the coefficients in the matrix. >> >> It looks like snes ex5, ksp ex32, and ksp ex34 rearrange the terms like this: >> >> >> dy dz (u(i-1,j,k) - 2u(i,j,k) + u(i+1,j,k)) dx dz (u(i,j-1,k) - 2u(i,j,k) + u(i,j+1,k)) dx dy (u(i,j,k-1) - 2u(i,j,k) + u(i,j,k+1)) >> --------------------------------------------------- + --------------------------------------------------- + --------------------------------------------------- = f dx dy dz >> dx dy dz >> >> >> I changed our code to use this approach and we observe much better convergence with the mg pre-conditioner. Is this renormalization? Can anyone explain why this change has such an impact on convergence with geometric multigrid as a pre-conditioner? It does not appear that the arrangement of coefficients affects convergence when using conjugate gradient without a pre-conditioner. Here?s output from some runs with the coefficients and right hand side modified as described above: >> >> >> $ mpirun -n 16 ./solver_test -da_grid_x 128 -da_grid_y 128 -da_grid_z 128 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 5 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 >> right hand side 2 norm: 0.000244141 >> right hand side infinity norm: 4.76406e-07 >> 0 KSP preconditioned resid norm 3.578255383614e+00 true resid norm 2.441406250000e-04 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 1.385321366208e-01 true resid norm 4.207234652404e-05 ||r(i)||/||b|| 1.723283313625e-01 >> 2 KSP preconditioned resid norm 4.459925861922e-03 true resid norm 1.480495515589e-06 ||r(i)||/||b|| 6.064109631854e-03 >> 3 KSP preconditioned resid norm 4.311025848794e-04 true resid norm 1.021041953365e-07 ||r(i)||/||b|| 4.182187840984e-04 >> 4 KSP preconditioned resid norm 1.619865162873e-05 true resid norm 5.438265013849e-09 ||r(i)||/||b|| 2.227513349673e-05 >> Linear solve converged due to CONVERGED_RTOL iterations 4 >> KSP final norm of residual 5.43827e-09 >> Residual 2 norm 5.43827e-09 >> Residual infinity norm 6.25328e-11 >> >> >> $ mpirun -n 16 ./solver_test -da_grid_x 128 -da_grid_y 128 -da_grid_z 128 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 5 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 -pc_mg_type full >> 0 KSP preconditioned resid norm 3.459879233358e+00 true resid norm 2.441406250000e-04 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 1.169574216505e-02 true resid norm 4.856676267753e-06 ||r(i)||/||b|| 1.989294599272e-02 >> 2 KSP preconditioned resid norm 1.158728408668e-04 true resid norm 1.603345697667e-08 ||r(i)||/||b|| 6.567303977645e-05 >> 3 KSP preconditioned resid norm 6.035498575583e-07 true resid norm 1.613378731540e-10 ||r(i)||/||b|| 6.608399284389e-07 >> Linear solve converged due to CONVERGED_RTOL iterations 3 >> KSP final norm of residual 1.61338e-10 >> Residual 2 norm 1.61338e-10 >> Residual infinity norm 1.95499e-12 >> >> >> $ mpirun -n 64 ./solver_test -da_grid_x 512 -da_grid_y 512 -da_grid_z 512 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 8 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 -pc_mg_type full -bc_type neumann >> right hand side 2 norm: 3.05176e-05 >> right hand side infinity norm: 7.45016e-09 >> 0 KSP preconditioned resid norm 5.330711358065e+01 true resid norm 3.051757812500e-05 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 4.687628546610e-04 true resid norm 2.452752396888e-08 ||r(i)||/||b|| 8.037179054124e-04 >> Linear solve converged due to CONVERGED_RTOL iterations 1 >> KSP final norm of residual 2.45275e-08 >> Residual 2 norm 2.45275e-08 >> Residual infinity norm 8.41572e-10 From damian at man.poznan.pl Tue Jul 4 04:16:07 2017 From: damian at man.poznan.pl (Damian Kaliszan) Date: Tue, 4 Jul 2017 11:16:07 +0200 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> <323017251.20170703111844@man.poznan.pl> <1946888301.20170703154737@man.poznan.pl> <1734368881.20170703162317@man.poznan.pl> Message-ID: <1391189420.20170704111607@man.poznan.pl> An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: slum_output.zip Type: application/x-zip-compressed Size: 2564136 bytes Desc: not available URL: From errabiisohaib at gmail.com Tue Jul 4 04:22:53 2017 From: errabiisohaib at gmail.com (errabii sohaib) Date: Tue, 4 Jul 2017 11:22:53 +0200 Subject: [petsc-users] Slepc reading distributed matrix from files Message-ID: Hi, I am trying to use petsc4py and slepc4py to read a matrix that is distributed on several files, In which i save the non zero elements by specifiying three arrays (A, I, J) for Coeffs, rows and columns indices. I am currently using MUMPS and i simply read a file and pass the A,I,J arrays to MUMPS with each process. I am trying to do the same, however i am still confused how matrices are structured in PETSc and if its even possible to read n files and pass the matrix to PETsc to solve with slepc4py using atleast n processes. Thank you very much for your time, Sohaib. -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Tue Jul 4 04:48:52 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Tue, 4 Jul 2017 11:48:52 +0200 Subject: [petsc-users] Slepc reading distributed matrix from files In-Reply-To: References: Message-ID: <0E7CA125-EB44-4E9D-A7F0-BD309C13280E@dsic.upv.es> > El 4 jul 2017, a las 11:22, errabii sohaib escribi?: > > Hi, > > I am trying to use petsc4py and slepc4py to read a matrix that is distributed on several files, In which i save the non zero elements by specifiying three arrays (A, I, J) for Coeffs, rows and columns indices. > I am currently using MUMPS and i simply read a file and pass the A,I,J arrays to MUMPS with each process. I am trying to do the same, however i am still confused how matrices are structured in PETSc and if its even possible to read n files and pass the matrix to PETsc to solve with slepc4py using atleast n processes. > > Thank you very much for your time, > Sohaib. > > > You can use createAIJWithArrays(), for instance I = [0, 2, 5, 8, 11, 14, 16] J = [0, 1, 0, 1, 2, 1, 2, 3, 2, 3, 4, 3, 4, 5, 4, 5] A = [2, -1, -1, 2, -1, -1, 2, -1, -1, 2, -1, -1, 2, -1, -1, 2] M = PETSc.Mat(); M.createAIJWithArrays([6, 6], (I,J,A)) M.view() Note that I is not the row index but the pointer to row start (according to the usual compressed sparse row format). Jose From pvsang002 at gmail.com Tue Jul 4 06:21:43 2017 From: pvsang002 at gmail.com (Pham Pham) Date: Tue, 4 Jul 2017 19:21:43 +0800 Subject: [petsc-users] Configure PETSc error Message-ID: Hi, I have the following error when configuring PETSc: Fortran compiler cannot handle preprocessing directives from command line. Please help to fix this. Thank you. HM. -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: configure.log Type: text/x-log Size: 5925507 bytes Desc: not available URL: From hsahasra at purdue.edu Tue Jul 4 07:31:57 2017 From: hsahasra at purdue.edu (Harshad Sahasrabudhe) Date: Tue, 4 Jul 2017 08:31:57 -0400 Subject: [petsc-users] Setting GAMG options C code Message-ID: Hello, I am using PCGAMG+KSPBCGS for shift and invert spectral transformation in SLEPc. I optimized the options that I need for GAMG using command line: -st_ksp_type bcgs -st_pc_type gamg -st_pc_gamg_agg_nsmooths 1 -st_mg_levels_ksp_type chebyshev -st_mg_levels_pc_type jacobi -st_mg_levels_ksp_max_it 8 -st_pc_gamg_threshold 0.01 How can I set these options inside my production code? Is okay to use PetscOptionsSetValue for setting the options as following? ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_type", "chebyshev"); chkerr(ierr); ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_pc_type", "jacobi"); chkerr(ierr); ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_max_it", "8"); chkerr(ierr); ierr = PetscOptionsSetValue(NULL, "-st_pc_gamg_threshold", "0.01"); chkerr(ierr); Thanks! Harshad -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Tue Jul 4 07:48:02 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Tue, 4 Jul 2017 14:48:02 +0200 Subject: [petsc-users] Setting GAMG options C code In-Reply-To: References: Message-ID: <57043691-AC72-42B6-8CA5-522553D9F3D3@dsic.upv.es> > El 4 jul 2017, a las 14:31, Harshad Sahasrabudhe escribi?: > > Hello, > > I am using PCGAMG+KSPBCGS for shift and invert spectral transformation in SLEPc. I optimized the options that I need for GAMG using command line: > > -st_ksp_type bcgs > -st_pc_type gamg > -st_pc_gamg_agg_nsmooths 1 > -st_mg_levels_ksp_type chebyshev > -st_mg_levels_pc_type jacobi > -st_mg_levels_ksp_max_it 8 > -st_pc_gamg_threshold 0.01 > > How can I set these options inside my production code? Is okay to use PetscOptionsSetValue for setting the options as following? > > ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_type", "chebyshev"); > chkerr(ierr); > ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_pc_type", "jacobi"); > chkerr(ierr); > ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_max_it", "8"); > chkerr(ierr); > ierr = PetscOptionsSetValue(NULL, "-st_pc_gamg_threshold", "0.01"); > chkerr(ierr); > > Thanks! > Harshad It is better to set pass the options directly to the objects. For instance the following example calls EPSGetST(), STGetKSP(), KSPGetPC() to extract objects that are nested one inside the other: http://slepc.upv.es/documentation/current/src/eps/examples/tutorials/ex12.c.html Jose From hsahasra at purdue.edu Tue Jul 4 07:54:27 2017 From: hsahasra at purdue.edu (Harshad Sahasrabudhe) Date: Tue, 4 Jul 2017 08:54:27 -0400 Subject: [petsc-users] Setting GAMG options C code In-Reply-To: <57043691-AC72-42B6-8CA5-522553D9F3D3@dsic.upv.es> References: <57043691-AC72-42B6-8CA5-522553D9F3D3@dsic.upv.es> Message-ID: Thank you for the reply. > It is better to set pass the options directly to the objects. For instance > the following example calls EPSGetST(), STGetKSP(), KSPGetPC() to extract > objects that are nested one inside the other: > > Jose > I was only able to set PCTYPE, KSPTYPE, -st_pc_gamg_agg_nsmooths 1 and -st_pc_gamg_threshold 0.01 that way. How do I set the options for the PCMG object inside PCGAMG: "-st_mg_levels_ksp_type chebyshev", "-st_mg_levels_pc_type jacobi", "-st_mg_levels_ksp_max_it 8"? Thanks, Harshad -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Tue Jul 4 08:05:39 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Tue, 4 Jul 2017 15:05:39 +0200 Subject: [petsc-users] Setting GAMG options C code In-Reply-To: References: <57043691-AC72-42B6-8CA5-522553D9F3D3@dsic.upv.es> Message-ID: <1514266F-01FD-48B6-88E5-DB1152287E32@dsic.upv.es> > El 4 jul 2017, a las 14:54, Harshad Sahasrabudhe escribi?: > > Thank you for the reply. > > It is better to set pass the options directly to the objects. For instance the following example calls EPSGetST(), STGetKSP(), KSPGetPC() to extract objects that are nested one inside the other: > > Jose > > I was only able to set PCTYPE, KSPTYPE, -st_pc_gamg_agg_nsmooths 1 and -st_pc_gamg_threshold 0.01 that way. How do I set the options for the PCMG object inside PCGAMG: "-st_mg_levels_ksp_type chebyshev", "-st_mg_levels_pc_type jacobi", "-st_mg_levels_ksp_max_it 8"? > > Thanks, > Harshad I am not too familiar with multi-grid but I think you must use PCMGGetSmoother(), then set KSP/PC options: http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/PC/PCMGGetSmoother.html Jose From knepley at gmail.com Tue Jul 4 08:28:50 2017 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 4 Jul 2017 08:28:50 -0500 Subject: [petsc-users] Setting GAMG options C code In-Reply-To: References: Message-ID: On Tue, Jul 4, 2017 at 7:31 AM, Harshad Sahasrabudhe wrote: > Hello, > > I am using PCGAMG+KSPBCGS for shift and invert spectral transformation in > SLEPc. I optimized the options that I need for GAMG using command line: > > -st_ksp_type bcgs > -st_pc_type gamg > -st_pc_gamg_agg_nsmooths 1 > -st_mg_levels_ksp_type chebyshev > -st_mg_levels_pc_type jacobi > -st_mg_levels_ksp_max_it 8 > -st_pc_gamg_threshold 0.01 > > How can I set these options inside my production code? Is okay to use PetscOptionsSetValue > for setting the options as following? > > ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_type", > "chebyshev"); > chkerr(ierr); > ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_pc_type", > "jacobi"); > chkerr(ierr); > ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_max_it", > "8"); > chkerr(ierr); > ierr = PetscOptionsSetValue(NULL, "-st_pc_gamg_threshold", > "0.01"); > chkerr(ierr); > I have a different opinion than Jose. I think the above lines are a better way to lock in the setup. 1) It is very difficult to get the order correct when you use the API 2) For deeply nested solvers it can be either inflexible (you assume a structure) or laborious (since you check for certain structures at each level) Thanks, Matt > Thanks! > Harshad > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From hsahasra at purdue.edu Tue Jul 4 09:06:16 2017 From: hsahasra at purdue.edu (Harshad Sahasrabudhe) Date: Tue, 4 Jul 2017 10:06:16 -0400 Subject: [petsc-users] Setting GAMG options C code In-Reply-To: References: Message-ID: > > ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_type", >> "chebyshev"); >> chkerr(ierr); >> ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_pc_type", >> "jacobi"); >> chkerr(ierr); >> ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_max_it", >> "8"); >> chkerr(ierr); >> ierr = PetscOptionsSetValue(NULL, "-st_pc_gamg_threshold", >> "0.01"); >> chkerr(ierr); >> > > I have a different opinion than Jose. I think the above lines are a better > way to lock in the setup. > > 1) It is very difficult to get the order correct when you use the API > > 2) For deeply nested solvers it can be either inflexible (you assume a > structure) or laborious (since > you check for certain structures at each level) > > Thanks, > > Matt > Thanks Matt! I will use it by setting options. I have one question though: What happens if there are 2 conflicting options? -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Tue Jul 4 09:10:38 2017 From: knepley at gmail.com (Matthew Knepley) Date: Tue, 4 Jul 2017 09:10:38 -0500 Subject: [petsc-users] Setting GAMG options C code In-Reply-To: References: Message-ID: On Tue, Jul 4, 2017 at 9:06 AM, Harshad Sahasrabudhe wrote: > ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_type", >>> "chebyshev"); >>> chkerr(ierr); >>> ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_pc_type", >>> "jacobi"); >>> chkerr(ierr); >>> ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_max_it", >>> "8"); >>> chkerr(ierr); >>> ierr = PetscOptionsSetValue(NULL, "-st_pc_gamg_threshold", >>> "0.01"); >>> chkerr(ierr); >>> >> >> I have a different opinion than Jose. I think the above lines are a >> better way to lock in the setup. >> >> 1) It is very difficult to get the order correct when you use the API >> >> 2) For deeply nested solvers it can be either inflexible (you assume a >> structure) or laborious (since >> you check for certain structures at each level) >> >> Thanks, >> >> Matt >> > > Thanks Matt! I will use it by setting options. I have one question though: > What happens if there are 2 conflicting options? > Last one wins, just like sports. Matt -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From jason.lefley at aclectic.com Mon Jul 3 10:06:58 2017 From: jason.lefley at aclectic.com (Jason Lefley) Date: Mon, 3 Jul 2017 11:06:58 -0400 Subject: [petsc-users] Issue using multi-grid as a pre-conditioner with KSP for a Poisson problem In-Reply-To: References: <89C033B5-529D-4B36-B4AF-2EC35CA2CCAB@aclectic.com> <4D5B3921-810B-49AD-97E9-8BF1DECBF655@aclectic.com> <063A8337-A2DC-4869-8E55-451F0F6F592C@aclectic.com> Message-ID: > On Jun 26, 2017, at 7:52 PM, Matthew Knepley wrote: > > On Mon, Jun 26, 2017 at 8:37 PM, Jason Lefley > wrote: >> Okay, when you say a Poisson problem, I assumed you meant >> >> div grad phi = f >> >> However, now it appears that you have >> >> div D grad phi = f >> >> Is this true? It would explain your results. Your coarse operator is inaccurate. AMG makes the coarse operator directly >> from the matrix, so it incorporates coefficient variation. Galerkin projection makes the coarse operator using R A P >> from your original operator A, and this is accurate enough to get good convergence. So your coefficient representation >> on the coarse levels is really bad. If you want to use GMG, you need to figure out how to represent the coefficient on >> coarser levels, which is sometimes called "renormalization". >> >> Matt > > I believe we are solving the first one. The discretized form we are using is equation 13 in this document: https://www.rsmas.miami.edu/users/miskandarani/Courses/MSC321/Projects/prjpoisson.pdf Would you clarify why you think we are solving the second equation? > > Something is wrong. The writeup is just showing the FD Laplacian. Can you take a look at SNES ex5, and let > me know how your problem differs from that one? There were use GMG and can converge is a few (5-6) iterates, > and if you use FMG you converge in 1 iterate. In fact, that is in my class notes on the CAAM 519 website. Its possible > that you have badly scaled boundary values, which can cause convergence to deteriorate. > > Thanks, > > Matt > I went through ex5 and some of the other Poisson/multigrid examples again and noticed that they arrange the coefficients in a particular way. Our original attempt (solver_test.c) and some related codes that solve similar problems use an arrangement like this: u(i-1,j,k) - 2u(i,j,k) + u(i+1,j,k) u(i,j-1,k) - 2u(i,j,k) + u(i,j+1,k) u(i,j,k-1) - 2u(i,j,k) + u(i,j,k+1) ---------------------------------------- + ---------------------------------------- + ---------------------------------------- = f dx^2 dy^2 dz^2 That results in the coefficient matrix containing -2 * (1/dx^2 + 1/dy^2 + 1/dz^2) on the diagonal and 1/dx^2, 1/dy^2 and 1/dz^2 on the off-diagonals. I?ve also looked at some codes that assume h = dx = dy = dz, multiply f by h^2 and then use -6 and 1 for the coefficients in the matrix. It looks like snes ex5, ksp ex32, and ksp ex34 rearrange the terms like this: dy dz (u(i-1,j,k) - 2u(i,j,k) + u(i+1,j,k)) dx dz (u(i,j-1,k) - 2u(i,j,k) + u(i,j+1,k)) dx dy (u(i,j,k-1) - 2u(i,j,k) + u(i,j,k+1)) --------------------------------------------------- + --------------------------------------------------- + --------------------------------------------------- = f dx dy dz dx dy dz I changed our code to use this approach and we observe much better convergence with the mg pre-conditioner. Is this renormalization? Can anyone explain why this change has such an impact on convergence with geometric multigrid as a pre-conditioner? It does not appear that the arrangement of coefficients affects convergence when using conjugate gradient without a pre-conditioner. Here?s output from some runs with the coefficients and right hand side modified as described above: $ mpirun -n 16 ./solver_test -da_grid_x 128 -da_grid_y 128 -da_grid_z 128 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 5 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 right hand side 2 norm: 0.000244141 right hand side infinity norm: 4.76406e-07 0 KSP preconditioned resid norm 3.578255383614e+00 true resid norm 2.441406250000e-04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.385321366208e-01 true resid norm 4.207234652404e-05 ||r(i)||/||b|| 1.723283313625e-01 2 KSP preconditioned resid norm 4.459925861922e-03 true resid norm 1.480495515589e-06 ||r(i)||/||b|| 6.064109631854e-03 3 KSP preconditioned resid norm 4.311025848794e-04 true resid norm 1.021041953365e-07 ||r(i)||/||b|| 4.182187840984e-04 4 KSP preconditioned resid norm 1.619865162873e-05 true resid norm 5.438265013849e-09 ||r(i)||/||b|| 2.227513349673e-05 Linear solve converged due to CONVERGED_RTOL iterations 4 KSP final norm of residual 5.43827e-09 Residual 2 norm 5.43827e-09 Residual infinity norm 6.25328e-11 $ mpirun -n 16 ./solver_test -da_grid_x 128 -da_grid_y 128 -da_grid_z 128 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 5 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 -pc_mg_type full 0 KSP preconditioned resid norm 3.459879233358e+00 true resid norm 2.441406250000e-04 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.169574216505e-02 true resid norm 4.856676267753e-06 ||r(i)||/||b|| 1.989294599272e-02 2 KSP preconditioned resid norm 1.158728408668e-04 true resid norm 1.603345697667e-08 ||r(i)||/||b|| 6.567303977645e-05 3 KSP preconditioned resid norm 6.035498575583e-07 true resid norm 1.613378731540e-10 ||r(i)||/||b|| 6.608399284389e-07 Linear solve converged due to CONVERGED_RTOL iterations 3 KSP final norm of residual 1.61338e-10 Residual 2 norm 1.61338e-10 Residual infinity norm 1.95499e-12 $ mpirun -n 64 ./solver_test -da_grid_x 512 -da_grid_y 512 -da_grid_z 512 -ksp_monitor_true_residual -pc_type mg -ksp_type cg -pc_mg_levels 8 -mg_levels_ksp_type richardson -mg_levels_ksp_richardson_self_scale -mg_levels_ksp_max_it 5 -pc_mg_type full -bc_type neumann right hand side 2 norm: 3.05176e-05 right hand side infinity norm: 7.45016e-09 0 KSP preconditioned resid norm 5.330711358065e+01 true resid norm 3.051757812500e-05 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 4.687628546610e-04 true resid norm 2.452752396888e-08 ||r(i)||/||b|| 8.037179054124e-04 Linear solve converged due to CONVERGED_RTOL iterations 1 KSP final norm of residual 2.45275e-08 Residual 2 norm 2.45275e-08 Residual infinity norm 8.41572e-10 -------------- next part -------------- An HTML attachment was scrubbed... URL: From robert.annewandter at opengosim.com Tue Jul 4 11:59:42 2017 From: robert.annewandter at opengosim.com (Robert Annewandter) Date: Tue, 4 Jul 2017 17:59:42 +0100 Subject: [petsc-users] Hypre BoomerAMG has slow convergence Message-ID: <292f17f2-ff3f-d323-0fec-555f97289cd2@opengosim.com> Hi all, I'm working on a CPR-AMG Two-Stage preconditioner implemented as multiplicative PCComposite with outer FGMRES, where the first PC is Hypre AMG (PCGalerkin + KSPRichardson + PCHYPRE) and the second stage is Block Jacobi with LU. The pde's describe two-phase subsurface flow, and I kept the problem small at 8000 x 8000 dofs. The first stage is hard-wired because of the PCGalerkin part and the second stage Block Jacobi is configured via command line (with pflotran prefix flow_): -flow_sub_1_pc_type bjacobi \ -flow_sub_1_sub_pc_type lu \ With this configuration I see occasionally that Hypre struggles to converge fast: Step 16 0 2r: 3.95E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 2.53E-03 iu: 0.00E+00 rsn: 0 Residual norms for flow_ solve. 0 KSP unpreconditioned resid norm 3.945216988332e-03 true resid norm 3.945216988332e-03 ||r(i)||/||b|| 1.000000000000e+00 Residual norms for flow_sub_0_galerkin_ solve. 0 KSP preconditioned resid norm 2.495457360562e+08 true resid norm 9.213492769259e-01 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.900401635809e+07 true resid norm 1.211813734614e-01 ||r(i)||/||b|| 1.315259874797e-01 2 KSP preconditioned resid norm 7.264015944695e+06 true resid norm 2.127154159346e-02 ||r(i)||/||b|| 2.308738078618e-02 3 KSP preconditioned resid norm 1.523934370189e+06 true resid norm 4.507204888834e-03 ||r(i)||/||b|| 4.891961172285e-03 4 KSP preconditioned resid norm 3.456355485206e+05 true resid norm 1.017486337883e-03 ||r(i)||/||b|| 1.104343774250e-03 5 KSP preconditioned resid norm 8.215494701640e+04 true resid norm 2.386758602821e-04 ||r(i)||/||b|| 2.590503582729e-04 6 KSP preconditioned resid norm 2.006221595869e+04 true resid norm 5.806707975375e-05 ||r(i)||/||b|| 6.302395975986e-05 7 KSP preconditioned resid norm 4.975749682114e+03 true resid norm 1.457831681999e-05 ||r(i)||/||b|| 1.582279075383e-05 8 KSP preconditioned resid norm 1.245359749620e+03 true resid norm 3.746721600730e-06 ||r(i)||/||b|| 4.066559441204e-06 9 KSP preconditioned resid norm 3.134373137075e+02 true resid norm 9.784665277082e-07 ||r(i)||/||b|| 1.061993048904e-06 10 KSP preconditioned resid norm 7.917076489741e+01 true resid norm 2.582765351245e-07 ||r(i)||/||b|| 2.803242392356e-07 11 KSP preconditioned resid norm 2.004702594193e+01 true resid norm 6.867609287185e-08 ||r(i)||/||b|| 7.453860831257e-08 1 KSP unpreconditioned resid norm 3.022346103074e-11 true resid norm 3.022346103592e-11 ||r(i)||/||b|| 7.660785484121e-09 1 2r: 2.87E-04 2x: 3.70E+09 2u: 3.36E+02 ir: 1.67E-04 iu: 2.19E+01 rsn: stol Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 Step 17 0 2r: 3.85E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 2.69E-03 iu: 0.00E+00 rsn: 0 Residual norms for flow_ solve. 0 KSP unpreconditioned resid norm 3.846677237838e-03 true resid norm 3.846677237838e-03 ||r(i)||/||b|| 1.000000000000e+00 Residual norms for flow_sub_0_galerkin_ solve. 0 KSP preconditioned resid norm 8.359592959751e+07 true resid norm 8.919381920269e-01 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.046474217608e+07 true resid norm 1.356172589724e+00 ||r(i)||/||b|| 1.520478214574e+00 2 KSP preconditioned resid norm 5.534610937223e+06 true resid norm 1.361527715124e+00 ||r(i)||/||b|| 1.526482134406e+00 3 KSP preconditioned resid norm 1.642592089665e+06 true resid norm 1.359990274368e+00 ||r(i)||/||b|| 1.524758426677e+00 4 KSP preconditioned resid norm 6.869446528993e+05 true resid norm 1.357740694885e+00 ||r(i)||/||b|| 1.522236301823e+00 5 KSP preconditioned resid norm 5.245968674991e+05 true resid norm 1.355364470917e+00 ||r(i)||/||b|| 1.519572189007e+00 6 KSP preconditioned resid norm 5.042030663187e+05 true resid norm 1.352962944308e+00 ||r(i)||/||b|| 1.516879708036e+00 7 KSP preconditioned resid norm 5.007302249221e+05 true resid norm 1.350558656878e+00 ||r(i)||/||b|| 1.514184131760e+00 8 KSP preconditioned resid norm 4.994105316949e+05 true resid norm 1.348156961110e+00 ||r(i)||/||b|| 1.511491461137e+00 9 KSP preconditioned resid norm 4.984373051647e+05 true resid norm 1.345759135434e+00 ||r(i)||/||b|| 1.508803129481e+00 10 KSP preconditioned resid norm 4.975323739321e+05 true resid norm 1.343365479502e+00 ||r(i)||/||b|| 1.506119472750e+00 11 KSP preconditioned resid norm 4.966432959339e+05 true resid norm 1.340976058673e+00 ||r(i)||/||b|| 1.503440564224e+00 [...] 193 KSP preconditioned resid norm 3.591931201817e+05 true resid norm 9.698521332569e-01 ||r(i)||/||b|| 1.087353520599e+00 194 KSP preconditioned resid norm 3.585542278288e+05 true resid norm 9.681270691497e-01 ||r(i)||/||b|| 1.085419458213e+00 195 KSP preconditioned resid norm 3.579164717745e+05 true resid norm 9.664050733935e-01 ||r(i)||/||b|| 1.083488835922e+00 196 KSP preconditioned resid norm 3.572798501551e+05 true resid norm 9.646861405301e-01 ||r(i)||/||b|| 1.081561647605e+00 197 KSP preconditioned resid norm 3.566443608646e+05 true resid norm 9.629702651108e-01 ||r(i)||/||b|| 1.079637887153e+00 198 KSP preconditioned resid norm 3.560100018703e+05 true resid norm 9.612574416991e-01 ||r(i)||/||b|| 1.077717548471e+00 199 KSP preconditioned resid norm 3.553767713002e+05 true resid norm 9.595476648643e-01 ||r(i)||/||b|| 1.075800625471e+00 200 KSP preconditioned resid norm 3.547446669197e+05 true resid norm 9.578409291897e-01 ||r(i)||/||b|| 1.073887112080e+00 1 KSP unpreconditioned resid norm 3.816569407795e-11 true resid norm 3.816569407353e-11 ||r(i)||/||b|| 9.921730291825e-09 1 2r: 2.74E-02 2x: 3.70E+09 2u: 1.23E+02 ir: 1.99E-02 iu: 2.71E+01 rsn: stol Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 Step 18 0 2r: 2.73E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 2.02E-02 iu: 0.00E+00 rsn: 0 Residual norms for flow_ solve. 0 KSP unpreconditioned resid norm 2.734891161446e-02 true resid norm 2.734891161446e-02 ||r(i)||/||b|| 1.000000000000e+00 Residual norms for flow_sub_0_galerkin_ solve. 0 KSP preconditioned resid norm 3.550345478098e+07 true resid norm 1.048585361984e+00 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 6.139218831613e+06 true resid norm 1.797822962324e-02 ||r(i)||/||b|| 1.714522276873e-02 2 KSP preconditioned resid norm 1.301871956838e+06 true resid norm 3.761355992926e-03 ||r(i)||/||b|| 3.587076578878e-03 3 KSP preconditioned resid norm 3.070518418113e+05 true resid norm 9.283056182563e-04 ||r(i)||/||b|| 8.852933217570e-04 4 KSP preconditioned resid norm 7.639640178912e+04 true resid norm 2.348078927331e-04 ||r(i)||/||b|| 2.239282572941e-04 5 KSP preconditioned resid norm 1.953032767966e+04 true resid norm 5.930230662989e-05 ||r(i)||/||b|| 5.655458180124e-05 6 KSP preconditioned resid norm 5.066937883132e+03 true resid norm 1.497534370201e-05 ||r(i)||/||b|| 1.428147315892e-05 7 KSP preconditioned resid norm 1.326441080568e+03 true resid norm 3.793872760594e-06 ||r(i)||/||b|| 3.618086708188e-06 8 KSP preconditioned resid norm 3.494353490063e+02 true resid norm 9.659536247849e-07 ||r(i)||/||b|| 9.211969380896e-07 9 KSP preconditioned resid norm 9.251497983280e+01 true resid norm 2.472922526467e-07 ||r(i)||/||b|| 2.358341644011e-07 10 KSP preconditioned resid norm 2.459917675189e+01 true resid norm 6.364691902290e-08 ||r(i)||/||b|| 6.069789006257e-08 11 KSP preconditioned resid norm 6.566117552226e+00 true resid norm 1.646205416458e-08 ||r(i)||/||b|| 1.569929808426e-08 12 KSP preconditioned resid norm 1.758927386308e+00 true resid norm 4.277033775892e-09 ||r(i)||/||b|| 4.078860845245e-09 1 KSP unpreconditioned resid norm 2.831146511164e-10 true resid norm 2.831146511142e-10 ||r(i)||/||b|| 1.035195312725e-08 1 2r: 1.31E-02 2x: 3.70E+09 2u: 3.66E+02 ir: 9.77E-03 iu: 6.03E+01 rsn: stol Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 SNES_view: SNES Object: (flow_) 2 MPI processes type: newtonls maximum iterations=8, maximum function evaluations=10000 tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 total number of linear solver iterations=1 total number of function evaluations=2 norm schedule ALWAYS SNESLineSearch Object: (flow_) 2 MPI processes type: basic maxstep=1.000000e+08, minlambda=1.000000e-05 tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 maximum iterations=40 using user-defined precheck step KSP Object: (flow_) 2 MPI processes type: fgmres GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement GMRES: happy breakdown tolerance 1e-30 maximum iterations=200, initial guess is zero tolerances: relative=1e-07, absolute=1e-50, divergence=10000. right preconditioning using UNPRECONDITIONED norm type for convergence test PC Object: (flow_) 2 MPI processes type: composite Composite PC type - MULTIPLICATIVE PCs on composite preconditioner follow --------------------------------- PC Object: (flow_sub_0_) 2 MPI processes type: galerkin Galerkin PC KSP on Galerkin follow --------------------------------- KSP Object: (flow_sub_0_galerkin_) 2 MPI processes type: richardson Richardson: damping factor=1. maximum iterations=200, initial guess is zero tolerances: relative=1e-07, absolute=1e-50, divergence=10000. left preconditioning using PRECONDITIONED norm type for convergence test PC Object: (flow_sub_0_galerkin_) 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=8000, cols=8000 total: nonzeros=53600, allocated nonzeros=53600 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines linear system matrix = precond matrix: Mat Object: (flow_) 2 MPI processes type: mpibaij rows=24000, cols=24000, bs=3 total: nonzeros=482400, allocated nonzeros=482400 total number of mallocs used during MatSetValues calls =0 PC Object: (flow_sub_1_) 2 MPI processes type: bjacobi block Jacobi: number of blocks = 2 Local solve is same for all blocks, in the following KSP and PC objects: KSP Object: (flow_sub_1_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: (flow_sub_1_sub_) 1 MPI processes type: lu out-of-place factorization tolerance for zero pivot 2.22045e-14 matrix ordering: nd factor fill ratio given 5., needed 18.3108 Factored matrix follows: Mat Object: 1 MPI processes type: seqbaij rows=12000, cols=12000, bs=3 package used to perform factorization: petsc total: nonzeros=4350654, allocated nonzeros=4350654 total number of mallocs used during MatSetValues calls =0 block size is 3 linear system matrix = precond matrix: Mat Object: (flow_) 1 MPI processes type: seqbaij rows=12000, cols=12000, bs=3 total: nonzeros=237600, allocated nonzeros=237600 total number of mallocs used during MatSetValues calls =0 block size is 3 linear system matrix = precond matrix: Mat Object: (flow_) 2 MPI processes type: mpibaij rows=24000, cols=24000, bs=3 total: nonzeros=482400, allocated nonzeros=482400 total number of mallocs used during MatSetValues calls =0 --------------------------------- linear system matrix = precond matrix: Mat Object: (flow_) 2 MPI processes type: mpibaij rows=24000, cols=24000, bs=3 total: nonzeros=482400, allocated nonzeros=482400 total number of mallocs used during MatSetValues calls =0 Is there a way to improve on the AMG part? Do I have to adjust the tolerances (make the inner tighter)? Which Hypre AMG parameters are worth tuning? This problem occurs for 1 MPI process as well, and solving the problem in Standard PFLOTRAN (i.e. Block Jacobi + ILU) is without any issue. Grateful for any help! Robert -------------- next part -------------- An HTML attachment was scrubbed... URL: From may at bu.edu Tue Jul 4 12:04:12 2017 From: may at bu.edu (Young, Matthew, Adam) Date: Tue, 4 Jul 2017 17:04:12 +0000 Subject: [petsc-users] Setting GAMG options C code In-Reply-To: References: , Message-ID: I couldn't resist. Please forgive me. ________________________________ From: petsc-users-bounces at mcs.anl.gov on behalf of Matthew Knepley Sent: Tuesday, July 4, 2017 10:10:38 AM To: Harshad Sahasrabudhe Cc: PETSc Subject: Re: [petsc-users] Setting GAMG options C code On Tue, Jul 4, 2017 at 9:06 AM, Harshad Sahasrabudhe > wrote: ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_type", "chebyshev"); chkerr(ierr); ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_pc_type", "jacobi"); chkerr(ierr); ierr = PetscOptionsSetValue(NULL, "-st_mg_levels_ksp_max_it", "8"); chkerr(ierr); ierr = PetscOptionsSetValue(NULL, "-st_pc_gamg_threshold", "0.01"); chkerr(ierr); I have a different opinion than Jose. I think the above lines are a better way to lock in the setup. 1) It is very difficult to get the order correct when you use the API 2) For deeply nested solvers it can be either inflexible (you assume a structure) or laborious (since you check for certain structures at each level) Thanks, Matt Thanks Matt! I will use it by setting options. I have one question though: What happens if there are 2 conflicting options? Last one wins, just like sports. Matt -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: knepley_sports.jpg Type: image/jpeg Size: 30070 bytes Desc: knepley_sports.jpg URL: From bsmith at mcs.anl.gov Tue Jul 4 12:04:36 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 4 Jul 2017 12:04:36 -0500 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <1391189420.20170704111607@man.poznan.pl> References: <2AEC6AB1-D4BD-4615-A99A-C0CFB140A5AF@mcs.anl.gov> <2ba0b4c0-e16c-44c6-a9ed-2e6f4d97d89e@man.poznan.pl> <323017251.20170703111844@man.poznan.pl> <1946888301.20170703154737@man.poznan.pl> <1734368881.20170703162317@man.poznan.pl> <1391189420.20170704111607@man.poznan.pl> Message-ID: <54F3F9BA-DD4E-46B9-91C9-3850293DFE18@mcs.anl.gov> You may need to ask a slurm expert. I have no idea what cpus-per-task means > On Jul 4, 2017, at 4:16 AM, Damian Kaliszan wrote: > > Hi, > > Yes, this is exactly what I meant. > Please find attached output for 2 input datasets and for 2 various slurm configs each: > > A/ Matrix size=8000000x8000000 > > 1/ slurm-14432809.out, 930 ksp steps, ~90 secs > > > #SBATCH --nodes=2 > #SBATCH --ntasks=32 > #SBATCH --ntasks-per-node=16 > #SBATCH --cpus-per-task=4 > > 2/ slurm-14432810.out , 100.000 ksp steps, ~9700 secs > > #SBATCH --nodes=2 > #SBATCH --ntasks=32 > #SBATCH --ntasks-per-node=16 > #SBATCH --cpus-per-task=2 > > > > B/ Matrix size=1000x1000 > > 1/ slurm-23716.out, 511 ksp steps, ~ 28 secs > #SBATCH --nodes=1 > #SBATCH --ntasks=64 > #SBATCH --ntasks-per-node=64 > #SBATCH --cpus-per-task=4 > > > 2/ slurm-23718.out, 94 ksp steps, ~ 4 secs > > #SBATCH --nodes=1 > #SBATCH --ntasks=4 > #SBATCH --ntasks-per-node=4 > #SBATCH --cpus-per-task=4 > > > I would really appreciate any help...:) > > Best, > Damian > > > > W li?cie datowanym 3 lipca 2017 (16:29:15) napisano: > > > On Mon, Jul 3, 2017 at 9:23 AM, Damian Kaliszan wrote: > Hi, > > > >> 1) You can call Bcast on PETSC_COMM_WORLD > > To be honest I can't find Bcast method in petsc4py.PETSc.Comm (I'm > using petsc4py) > > >> 2) If you are using WORLD, the number of iterates will be the same on each process since iteration is collective. > > Yes, this is how it should be. But what I noticed is that for > different --cpus-per-task numbers in slurm script I get different > number of solver iterations which is in turn related to timings. The > imparity is huge. For example for some configurations where --cpus-per-task=1 I receive 900 > iterations and for --cpus-per-task=2 I receive valid number of 100.000 which is set as max > iter number set when setting solver tolerances. > > I am trying to understand what you are saying. You mean that you make 2 different runs and get a different > number of iterates with a KSP? In order to answer questions about convergence, we need to see the output > of > > -ksp_view -ksp_monitor_true_residual -ksp_converged_reason > > for all cases. > > Thanks, > > Matt > > Best, > Damian > > > > > -- > What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ > > > > > > ------------------------------------------------------- > Damian Kaliszan > > Poznan Supercomputing and Networking Center > HPC and Data Centres Technologies > ul. Jana Paw?a II 10 > 61-139 Poznan > POLAND > > phone (+48 61) 858 5109 > e-mail damian at man.poznan.pl > www - http://www.man.poznan.pl/ > ------------------------------------------------------- > From bsmith at mcs.anl.gov Tue Jul 4 12:08:10 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 4 Jul 2017 12:08:10 -0500 Subject: [petsc-users] Slepc reading distributed matrix from files In-Reply-To: References: Message-ID: We recommend writing a utility program that runs on one process and reads in the files putting the values into a matrix then using MatView() with a binary viewer to save the matrix to a file. Then in your parallel program you simply call MatLoad() and it efficiently loads up the matrix into your program in parallel. This means you don't need to write a parallel reader, you only need to write a sequential one which is easier. Barry > On Jul 4, 2017, at 4:22 AM, errabii sohaib wrote: > > Hi, > > I am trying to use petsc4py and slepc4py to read a matrix that is distributed on several files, In which i save the non zero elements by specifiying three arrays (A, I, J) for Coeffs, rows and columns indices. > I am currently using MUMPS and i simply read a file and pass the A,I,J arrays to MUMPS with each process. I am trying to do the same, however i am still confused how matrices are structured in PETSc and if its even possible to read n files and pass the matrix to PETsc to solve with slepc4py using atleast n processes. > > Thank you very much for your time, > Sohaib. > > > From errabiisohaib at gmail.com Tue Jul 4 12:19:38 2017 From: errabiisohaib at gmail.com (errabii sohaib) Date: Tue, 4 Jul 2017 19:19:38 +0200 Subject: [petsc-users] Slepc reading distributed matrix from files In-Reply-To: References: Message-ID: This is an awesome tip thank you so much. I have written an embarassingly parallel reader (since i am reading from several files) but i was worried that my main program won't be able to use more processors than the number of files, but this tip should save me so much trouble. Thank you. 2017-07-04 19:08 GMT+02:00 Barry Smith : > > We recommend writing a utility program that runs on one process and > reads in the files putting the values into a matrix then using MatView() > with a binary viewer to save the matrix to a file. > > Then in your parallel program you simply call MatLoad() and it > efficiently loads up the matrix into your program in parallel. > > This means you don't need to write a parallel reader, you only need > to write a sequential one which is easier. > > Barry > > > On Jul 4, 2017, at 4:22 AM, errabii sohaib > wrote: > > > > Hi, > > > > I am trying to use petsc4py and slepc4py to read a matrix that is > distributed on several files, In which i save the non zero elements by > specifiying three arrays (A, I, J) for Coeffs, rows and columns indices. > > I am currently using MUMPS and i simply read a file and pass the A,I,J > arrays to MUMPS with each process. I am trying to do the same, however i am > still confused how matrices are structured in PETSc and if its even > possible to read n files and pass the matrix to PETsc to solve with > slepc4py using atleast n processes. > > > > Thank you very much for your time, > > Sohaib. > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Tue Jul 4 12:24:38 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Tue, 4 Jul 2017 12:24:38 -0500 Subject: [petsc-users] Hypre BoomerAMG has slow convergence In-Reply-To: <292f17f2-ff3f-d323-0fec-555f97289cd2@opengosim.com> References: <292f17f2-ff3f-d323-0fec-555f97289cd2@opengosim.com> Message-ID: <03D4AAAA-AFD3-4F07-914A-9DAEDB30E1AF@mcs.anl.gov> The large preconditioned norm relative to the true residual norm is often a sign that the preconditioner is not happy. 0 KSP preconditioned resid norm 2.495457360562e+08 true resid norm 9.213492769259e-01 ||r(i)||/||b|| 1.000000000000e+00 Is there any chance this subproblem is singular? Run with -flow_sub_0_galerkin_ksp_view_mat binary -flow_sub_0_galerkin_ksp_view_rhs binary for 18 stages. This will save the matrices and the right hand sides for the 18 systems passed to hypre in a file called binaryoutput. Email the file to petsc-maint at mcs.anl.gov Barry > On Jul 4, 2017, at 11:59 AM, Robert Annewandter wrote: > > Hi all, > > > I'm working on a CPR-AMG Two-Stage preconditioner implemented as multiplicative PCComposite with outer FGMRES, where the first PC is Hypre AMG (PCGalerkin + KSPRichardson + PCHYPRE) and the second stage is Block Jacobi with LU. The pde's describe two-phase subsurface flow, and I kept the problem small at 8000 x 8000 dofs. > > The first stage is hard-wired because of the PCGalerkin part and the second stage Block Jacobi is configured via command line (with pflotran prefix flow_): > > -flow_sub_1_pc_type bjacobi \ > -flow_sub_1_sub_pc_type lu \ > > With this configuration I see occasionally that Hypre struggles to converge fast: > > > Step 16 > > 0 2r: 3.95E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 2.53E-03 iu: 0.00E+00 rsn: 0 > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 3.945216988332e-03 true resid norm 3.945216988332e-03 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 2.495457360562e+08 true resid norm 9.213492769259e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.900401635809e+07 true resid norm 1.211813734614e-01 ||r(i)||/||b|| 1.315259874797e-01 > 2 KSP preconditioned resid norm 7.264015944695e+06 true resid norm 2.127154159346e-02 ||r(i)||/||b|| 2.308738078618e-02 > 3 KSP preconditioned resid norm 1.523934370189e+06 true resid norm 4.507204888834e-03 ||r(i)||/||b|| 4.891961172285e-03 > 4 KSP preconditioned resid norm 3.456355485206e+05 true resid norm 1.017486337883e-03 ||r(i)||/||b|| 1.104343774250e-03 > 5 KSP preconditioned resid norm 8.215494701640e+04 true resid norm 2.386758602821e-04 ||r(i)||/||b|| 2.590503582729e-04 > 6 KSP preconditioned resid norm 2.006221595869e+04 true resid norm 5.806707975375e-05 ||r(i)||/||b|| 6.302395975986e-05 > 7 KSP preconditioned resid norm 4.975749682114e+03 true resid norm 1.457831681999e-05 ||r(i)||/||b|| 1.582279075383e-05 > 8 KSP preconditioned resid norm 1.245359749620e+03 true resid norm 3.746721600730e-06 ||r(i)||/||b|| 4.066559441204e-06 > 9 KSP preconditioned resid norm 3.134373137075e+02 true resid norm 9.784665277082e-07 ||r(i)||/||b|| 1.061993048904e-06 > 10 KSP preconditioned resid norm 7.917076489741e+01 true resid norm 2.582765351245e-07 ||r(i)||/||b|| 2.803242392356e-07 > 11 KSP preconditioned resid norm 2.004702594193e+01 true resid norm 6.867609287185e-08 ||r(i)||/||b|| 7.453860831257e-08 > 1 KSP unpreconditioned resid norm 3.022346103074e-11 true resid norm 3.022346103592e-11 ||r(i)||/||b|| 7.660785484121e-09 > 1 2r: 2.87E-04 2x: 3.70E+09 2u: 3.36E+02 ir: 1.67E-04 iu: 2.19E+01 rsn: stol > Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 > > > Step 17 > > 0 2r: 3.85E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 2.69E-03 iu: 0.00E+00 rsn: 0 > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 3.846677237838e-03 true resid norm 3.846677237838e-03 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 8.359592959751e+07 true resid norm 8.919381920269e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.046474217608e+07 true resid norm 1.356172589724e+00 ||r(i)||/||b|| 1.520478214574e+00 > 2 KSP preconditioned resid norm 5.534610937223e+06 true resid norm 1.361527715124e+00 ||r(i)||/||b|| 1.526482134406e+00 > 3 KSP preconditioned resid norm 1.642592089665e+06 true resid norm 1.359990274368e+00 ||r(i)||/||b|| 1.524758426677e+00 > 4 KSP preconditioned resid norm 6.869446528993e+05 true resid norm 1.357740694885e+00 ||r(i)||/||b|| 1.522236301823e+00 > 5 KSP preconditioned resid norm 5.245968674991e+05 true resid norm 1.355364470917e+00 ||r(i)||/||b|| 1.519572189007e+00 > 6 KSP preconditioned resid norm 5.042030663187e+05 true resid norm 1.352962944308e+00 ||r(i)||/||b|| 1.516879708036e+00 > 7 KSP preconditioned resid norm 5.007302249221e+05 true resid norm 1.350558656878e+00 ||r(i)||/||b|| 1.514184131760e+00 > 8 KSP preconditioned resid norm 4.994105316949e+05 true resid norm 1.348156961110e+00 ||r(i)||/||b|| 1.511491461137e+00 > 9 KSP preconditioned resid norm 4.984373051647e+05 true resid norm 1.345759135434e+00 ||r(i)||/||b|| 1.508803129481e+00 > 10 KSP preconditioned resid norm 4.975323739321e+05 true resid norm 1.343365479502e+00 ||r(i)||/||b|| 1.506119472750e+00 > 11 KSP preconditioned resid norm 4.966432959339e+05 true resid norm 1.340976058673e+00 ||r(i)||/||b|| 1.503440564224e+00 > [...] > 193 KSP preconditioned resid norm 3.591931201817e+05 true resid norm 9.698521332569e-01 ||r(i)||/||b|| 1.087353520599e+00 > 194 KSP preconditioned resid norm 3.585542278288e+05 true resid norm 9.681270691497e-01 ||r(i)||/||b|| 1.085419458213e+00 > 195 KSP preconditioned resid norm 3.579164717745e+05 true resid norm 9.664050733935e-01 ||r(i)||/||b|| 1.083488835922e+00 > 196 KSP preconditioned resid norm 3.572798501551e+05 true resid norm 9.646861405301e-01 ||r(i)||/||b|| 1.081561647605e+00 > 197 KSP preconditioned resid norm 3.566443608646e+05 true resid norm 9.629702651108e-01 ||r(i)||/||b|| 1.079637887153e+00 > 198 KSP preconditioned resid norm 3.560100018703e+05 true resid norm 9.612574416991e-01 ||r(i)||/||b|| 1.077717548471e+00 > 199 KSP preconditioned resid norm 3.553767713002e+05 true resid norm 9.595476648643e-01 ||r(i)||/||b|| 1.075800625471e+00 > 200 KSP preconditioned resid norm 3.547446669197e+05 true resid norm 9.578409291897e-01 ||r(i)||/||b|| 1.073887112080e+00 > 1 KSP unpreconditioned resid norm 3.816569407795e-11 true resid norm 3.816569407353e-11 ||r(i)||/||b|| 9.921730291825e-09 > 1 2r: 2.74E-02 2x: 3.70E+09 2u: 1.23E+02 ir: 1.99E-02 iu: 2.71E+01 rsn: stol > Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 > > Step 18 > > 0 2r: 2.73E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 2.02E-02 iu: 0.00E+00 rsn: 0 > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 2.734891161446e-02 true resid norm 2.734891161446e-02 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 3.550345478098e+07 true resid norm 1.048585361984e+00 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 6.139218831613e+06 true resid norm 1.797822962324e-02 ||r(i)||/||b|| 1.714522276873e-02 > 2 KSP preconditioned resid norm 1.301871956838e+06 true resid norm 3.761355992926e-03 ||r(i)||/||b|| 3.587076578878e-03 > 3 KSP preconditioned resid norm 3.070518418113e+05 true resid norm 9.283056182563e-04 ||r(i)||/||b|| 8.852933217570e-04 > 4 KSP preconditioned resid norm 7.639640178912e+04 true resid norm 2.348078927331e-04 ||r(i)||/||b|| 2.239282572941e-04 > 5 KSP preconditioned resid norm 1.953032767966e+04 true resid norm 5.930230662989e-05 ||r(i)||/||b|| 5.655458180124e-05 > 6 KSP preconditioned resid norm 5.066937883132e+03 true resid norm 1.497534370201e-05 ||r(i)||/||b|| 1.428147315892e-05 > 7 KSP preconditioned resid norm 1.326441080568e+03 true resid norm 3.793872760594e-06 ||r(i)||/||b|| 3.618086708188e-06 > 8 KSP preconditioned resid norm 3.494353490063e+02 true resid norm 9.659536247849e-07 ||r(i)||/||b|| 9.211969380896e-07 > 9 KSP preconditioned resid norm 9.251497983280e+01 true resid norm 2.472922526467e-07 ||r(i)||/||b|| 2.358341644011e-07 > 10 KSP preconditioned resid norm 2.459917675189e+01 true resid norm 6.364691902290e-08 ||r(i)||/||b|| 6.069789006257e-08 > 11 KSP preconditioned resid norm 6.566117552226e+00 true resid norm 1.646205416458e-08 ||r(i)||/||b|| 1.569929808426e-08 > 12 KSP preconditioned resid norm 1.758927386308e+00 true resid norm 4.277033775892e-09 ||r(i)||/||b|| 4.078860845245e-09 > 1 KSP unpreconditioned resid norm 2.831146511164e-10 true resid norm 2.831146511142e-10 ||r(i)||/||b|| 1.035195312725e-08 > 1 2r: 1.31E-02 2x: 3.70E+09 2u: 3.66E+02 ir: 9.77E-03 iu: 6.03E+01 rsn: stol > Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 > > > > SNES_view: > > > SNES Object: (flow_) 2 MPI processes > type: newtonls > maximum iterations=8, maximum function evaluations=10000 > tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 > total number of linear solver iterations=1 > total number of function evaluations=2 > norm schedule ALWAYS > SNESLineSearch Object: (flow_) 2 MPI processes > type: basic > maxstep=1.000000e+08, minlambda=1.000000e-05 > tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 > maximum iterations=40 > using user-defined precheck step > KSP Object: (flow_) 2 MPI processes > type: fgmres > GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > GMRES: happy breakdown tolerance 1e-30 > maximum iterations=200, initial guess is zero > tolerances: relative=1e-07, absolute=1e-50, divergence=10000. > right preconditioning > using UNPRECONDITIONED norm type for convergence test > PC Object: (flow_) 2 MPI processes > type: composite > Composite PC type - MULTIPLICATIVE > PCs on composite preconditioner follow > --------------------------------- > PC Object: (flow_sub_0_) 2 MPI processes > type: galerkin > Galerkin PC > KSP on Galerkin follow > --------------------------------- > KSP Object: (flow_sub_0_galerkin_) 2 MPI processes > type: richardson > Richardson: damping factor=1. > maximum iterations=200, initial guess is zero > tolerances: relative=1e-07, absolute=1e-50, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: (flow_sub_0_galerkin_) 2 MPI processes > type: hypre > HYPRE BoomerAMG preconditioning > HYPRE BoomerAMG: Cycle type V > HYPRE BoomerAMG: Maximum number of levels 25 > HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 > HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. > HYPRE BoomerAMG: Threshold for strong coupling 0.25 > HYPRE BoomerAMG: Interpolation truncation factor 0. > HYPRE BoomerAMG: Interpolation: max elements per row 0 > HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 > HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 > HYPRE BoomerAMG: Maximum row sums 0.9 > HYPRE BoomerAMG: Sweeps down 1 > HYPRE BoomerAMG: Sweeps up 1 > HYPRE BoomerAMG: Sweeps on coarse 1 > HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi > HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi > HYPRE BoomerAMG: Relax on coarse Gaussian-elimination > HYPRE BoomerAMG: Relax weight (all) 1. > HYPRE BoomerAMG: Outer relax weight (all) 1. > HYPRE BoomerAMG: Using CF-relaxation > HYPRE BoomerAMG: Not using more complex smoothers. > HYPRE BoomerAMG: Measure type local > HYPRE BoomerAMG: Coarsen type Falgout > HYPRE BoomerAMG: Interpolation type classical > linear system matrix = precond matrix: > Mat Object: 2 MPI processes > type: mpiaij > rows=8000, cols=8000 > total: nonzeros=53600, allocated nonzeros=53600 > total number of mallocs used during MatSetValues calls =0 > not using I-node (on process 0) routines > linear system matrix = precond matrix: > Mat Object: (flow_) 2 MPI processes > type: mpibaij > rows=24000, cols=24000, bs=3 > total: nonzeros=482400, allocated nonzeros=482400 > total number of mallocs used during MatSetValues calls =0 > PC Object: (flow_sub_1_) 2 MPI processes > type: bjacobi > block Jacobi: number of blocks = 2 > Local solve is same for all blocks, in the following KSP and PC objects: > KSP Object: (flow_sub_1_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: (flow_sub_1_sub_) 1 MPI processes > type: lu > out-of-place factorization > tolerance for zero pivot 2.22045e-14 > matrix ordering: nd > factor fill ratio given 5., needed 18.3108 > Factored matrix follows: > Mat Object: 1 MPI processes > type: seqbaij > rows=12000, cols=12000, bs=3 > package used to perform factorization: petsc > total: nonzeros=4350654, allocated nonzeros=4350654 > total number of mallocs used during MatSetValues calls =0 > block size is 3 > linear system matrix = precond matrix: > Mat Object: (flow_) 1 MPI processes > type: seqbaij > rows=12000, cols=12000, bs=3 > total: nonzeros=237600, allocated nonzeros=237600 > total number of mallocs used during MatSetValues calls =0 > block size is 3 > linear system matrix = precond matrix: > Mat Object: (flow_) 2 MPI processes > type: mpibaij > rows=24000, cols=24000, bs=3 > total: nonzeros=482400, allocated nonzeros=482400 > total number of mallocs used during MatSetValues calls =0 > --------------------------------- > linear system matrix = precond matrix: > Mat Object: (flow_) 2 MPI processes > type: mpibaij > rows=24000, cols=24000, bs=3 > total: nonzeros=482400, allocated nonzeros=482400 > total number of mallocs used during MatSetValues calls =0 > > > > Is there a way to improve on the AMG part? Do I have to adjust the tolerances (make the inner tighter)? Which Hypre AMG parameters are worth tuning? This problem occurs for 1 MPI process as well, and solving the problem in Standard PFLOTRAN (i.e. Block Jacobi + ILU) is without any issue. > > Grateful for any help! > Robert > > > From robert.annewandter at opengosim.com Tue Jul 4 13:40:45 2017 From: robert.annewandter at opengosim.com (Robert Annewandter) Date: Tue, 4 Jul 2017 19:40:45 +0100 Subject: [petsc-users] Hypre BoomerAMG has slow convergence In-Reply-To: <03D4AAAA-AFD3-4F07-914A-9DAEDB30E1AF@mcs.anl.gov> References: <292f17f2-ff3f-d323-0fec-555f97289cd2@opengosim.com> <03D4AAAA-AFD3-4F07-914A-9DAEDB30E1AF@mcs.anl.gov> Message-ID: Thank you Barry! I believe the sub problem can be singular, because the first preconditioner M1 in the CPR-AMG preconditioner Mcpr^(-1) = M2^(-1) [ I - J M1^(-1) ] + M1^(-1), where M1^(-1) = C [ W^T J C ]^(-1) W^T, has prolongation C and restriction W^T with size 3N x N resp. N x 3N (and 3 # of primary variables). Would that make sense? On 04/07/17 18:24, Barry Smith wrote: > The large preconditioned norm relative to the true residual norm is often a sign that the preconditioner is not happy. > > 0 KSP preconditioned resid norm 2.495457360562e+08 true resid norm 9.213492769259e-01 ||r(i)||/||b|| 1.000000000000e+00 > > Is there any chance this subproblem is singular? > > Run with -flow_sub_0_galerkin_ksp_view_mat binary -flow_sub_0_galerkin_ksp_view_rhs binary for 18 stages. This will save the matrices and the right hand sides for the 18 systems passed to hypre in a file called binaryoutput. Email the file to petsc-maint at mcs.anl.gov > > Barry > > >> On Jul 4, 2017, at 11:59 AM, Robert Annewandter wrote: >> >> Hi all, >> >> >> I'm working on a CPR-AMG Two-Stage preconditioner implemented as multiplicative PCComposite with outer FGMRES, where the first PC is Hypre AMG (PCGalerkin + KSPRichardson + PCHYPRE) and the second stage is Block Jacobi with LU. The pde's describe two-phase subsurface flow, and I kept the problem small at 8000 x 8000 dofs. >> >> The first stage is hard-wired because of the PCGalerkin part and the second stage Block Jacobi is configured via command line (with pflotran prefix flow_): >> >> -flow_sub_1_pc_type bjacobi \ >> -flow_sub_1_sub_pc_type lu \ >> >> With this configuration I see occasionally that Hypre struggles to converge fast: >> >> >> Step 16 >> >> 0 2r: 3.95E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 2.53E-03 iu: 0.00E+00 rsn: 0 >> Residual norms for flow_ solve. >> 0 KSP unpreconditioned resid norm 3.945216988332e-03 true resid norm 3.945216988332e-03 ||r(i)||/||b|| 1.000000000000e+00 >> Residual norms for flow_sub_0_galerkin_ solve. >> 0 KSP preconditioned resid norm 2.495457360562e+08 true resid norm 9.213492769259e-01 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 3.900401635809e+07 true resid norm 1.211813734614e-01 ||r(i)||/||b|| 1.315259874797e-01 >> 2 KSP preconditioned resid norm 7.264015944695e+06 true resid norm 2.127154159346e-02 ||r(i)||/||b|| 2.308738078618e-02 >> 3 KSP preconditioned resid norm 1.523934370189e+06 true resid norm 4.507204888834e-03 ||r(i)||/||b|| 4.891961172285e-03 >> 4 KSP preconditioned resid norm 3.456355485206e+05 true resid norm 1.017486337883e-03 ||r(i)||/||b|| 1.104343774250e-03 >> 5 KSP preconditioned resid norm 8.215494701640e+04 true resid norm 2.386758602821e-04 ||r(i)||/||b|| 2.590503582729e-04 >> 6 KSP preconditioned resid norm 2.006221595869e+04 true resid norm 5.806707975375e-05 ||r(i)||/||b|| 6.302395975986e-05 >> 7 KSP preconditioned resid norm 4.975749682114e+03 true resid norm 1.457831681999e-05 ||r(i)||/||b|| 1.582279075383e-05 >> 8 KSP preconditioned resid norm 1.245359749620e+03 true resid norm 3.746721600730e-06 ||r(i)||/||b|| 4.066559441204e-06 >> 9 KSP preconditioned resid norm 3.134373137075e+02 true resid norm 9.784665277082e-07 ||r(i)||/||b|| 1.061993048904e-06 >> 10 KSP preconditioned resid norm 7.917076489741e+01 true resid norm 2.582765351245e-07 ||r(i)||/||b|| 2.803242392356e-07 >> 11 KSP preconditioned resid norm 2.004702594193e+01 true resid norm 6.867609287185e-08 ||r(i)||/||b|| 7.453860831257e-08 >> 1 KSP unpreconditioned resid norm 3.022346103074e-11 true resid norm 3.022346103592e-11 ||r(i)||/||b|| 7.660785484121e-09 >> 1 2r: 2.87E-04 2x: 3.70E+09 2u: 3.36E+02 ir: 1.67E-04 iu: 2.19E+01 rsn: stol >> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 >> >> >> Step 17 >> >> 0 2r: 3.85E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 2.69E-03 iu: 0.00E+00 rsn: 0 >> Residual norms for flow_ solve. >> 0 KSP unpreconditioned resid norm 3.846677237838e-03 true resid norm 3.846677237838e-03 ||r(i)||/||b|| 1.000000000000e+00 >> Residual norms for flow_sub_0_galerkin_ solve. >> 0 KSP preconditioned resid norm 8.359592959751e+07 true resid norm 8.919381920269e-01 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 2.046474217608e+07 true resid norm 1.356172589724e+00 ||r(i)||/||b|| 1.520478214574e+00 >> 2 KSP preconditioned resid norm 5.534610937223e+06 true resid norm 1.361527715124e+00 ||r(i)||/||b|| 1.526482134406e+00 >> 3 KSP preconditioned resid norm 1.642592089665e+06 true resid norm 1.359990274368e+00 ||r(i)||/||b|| 1.524758426677e+00 >> 4 KSP preconditioned resid norm 6.869446528993e+05 true resid norm 1.357740694885e+00 ||r(i)||/||b|| 1.522236301823e+00 >> 5 KSP preconditioned resid norm 5.245968674991e+05 true resid norm 1.355364470917e+00 ||r(i)||/||b|| 1.519572189007e+00 >> 6 KSP preconditioned resid norm 5.042030663187e+05 true resid norm 1.352962944308e+00 ||r(i)||/||b|| 1.516879708036e+00 >> 7 KSP preconditioned resid norm 5.007302249221e+05 true resid norm 1.350558656878e+00 ||r(i)||/||b|| 1.514184131760e+00 >> 8 KSP preconditioned resid norm 4.994105316949e+05 true resid norm 1.348156961110e+00 ||r(i)||/||b|| 1.511491461137e+00 >> 9 KSP preconditioned resid norm 4.984373051647e+05 true resid norm 1.345759135434e+00 ||r(i)||/||b|| 1.508803129481e+00 >> 10 KSP preconditioned resid norm 4.975323739321e+05 true resid norm 1.343365479502e+00 ||r(i)||/||b|| 1.506119472750e+00 >> 11 KSP preconditioned resid norm 4.966432959339e+05 true resid norm 1.340976058673e+00 ||r(i)||/||b|| 1.503440564224e+00 >> [...] >> 193 KSP preconditioned resid norm 3.591931201817e+05 true resid norm 9.698521332569e-01 ||r(i)||/||b|| 1.087353520599e+00 >> 194 KSP preconditioned resid norm 3.585542278288e+05 true resid norm 9.681270691497e-01 ||r(i)||/||b|| 1.085419458213e+00 >> 195 KSP preconditioned resid norm 3.579164717745e+05 true resid norm 9.664050733935e-01 ||r(i)||/||b|| 1.083488835922e+00 >> 196 KSP preconditioned resid norm 3.572798501551e+05 true resid norm 9.646861405301e-01 ||r(i)||/||b|| 1.081561647605e+00 >> 197 KSP preconditioned resid norm 3.566443608646e+05 true resid norm 9.629702651108e-01 ||r(i)||/||b|| 1.079637887153e+00 >> 198 KSP preconditioned resid norm 3.560100018703e+05 true resid norm 9.612574416991e-01 ||r(i)||/||b|| 1.077717548471e+00 >> 199 KSP preconditioned resid norm 3.553767713002e+05 true resid norm 9.595476648643e-01 ||r(i)||/||b|| 1.075800625471e+00 >> 200 KSP preconditioned resid norm 3.547446669197e+05 true resid norm 9.578409291897e-01 ||r(i)||/||b|| 1.073887112080e+00 >> 1 KSP unpreconditioned resid norm 3.816569407795e-11 true resid norm 3.816569407353e-11 ||r(i)||/||b|| 9.921730291825e-09 >> 1 2r: 2.74E-02 2x: 3.70E+09 2u: 1.23E+02 ir: 1.99E-02 iu: 2.71E+01 rsn: stol >> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 >> >> Step 18 >> >> 0 2r: 2.73E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 2.02E-02 iu: 0.00E+00 rsn: 0 >> Residual norms for flow_ solve. >> 0 KSP unpreconditioned resid norm 2.734891161446e-02 true resid norm 2.734891161446e-02 ||r(i)||/||b|| 1.000000000000e+00 >> Residual norms for flow_sub_0_galerkin_ solve. >> 0 KSP preconditioned resid norm 3.550345478098e+07 true resid norm 1.048585361984e+00 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 6.139218831613e+06 true resid norm 1.797822962324e-02 ||r(i)||/||b|| 1.714522276873e-02 >> 2 KSP preconditioned resid norm 1.301871956838e+06 true resid norm 3.761355992926e-03 ||r(i)||/||b|| 3.587076578878e-03 >> 3 KSP preconditioned resid norm 3.070518418113e+05 true resid norm 9.283056182563e-04 ||r(i)||/||b|| 8.852933217570e-04 >> 4 KSP preconditioned resid norm 7.639640178912e+04 true resid norm 2.348078927331e-04 ||r(i)||/||b|| 2.239282572941e-04 >> 5 KSP preconditioned resid norm 1.953032767966e+04 true resid norm 5.930230662989e-05 ||r(i)||/||b|| 5.655458180124e-05 >> 6 KSP preconditioned resid norm 5.066937883132e+03 true resid norm 1.497534370201e-05 ||r(i)||/||b|| 1.428147315892e-05 >> 7 KSP preconditioned resid norm 1.326441080568e+03 true resid norm 3.793872760594e-06 ||r(i)||/||b|| 3.618086708188e-06 >> 8 KSP preconditioned resid norm 3.494353490063e+02 true resid norm 9.659536247849e-07 ||r(i)||/||b|| 9.211969380896e-07 >> 9 KSP preconditioned resid norm 9.251497983280e+01 true resid norm 2.472922526467e-07 ||r(i)||/||b|| 2.358341644011e-07 >> 10 KSP preconditioned resid norm 2.459917675189e+01 true resid norm 6.364691902290e-08 ||r(i)||/||b|| 6.069789006257e-08 >> 11 KSP preconditioned resid norm 6.566117552226e+00 true resid norm 1.646205416458e-08 ||r(i)||/||b|| 1.569929808426e-08 >> 12 KSP preconditioned resid norm 1.758927386308e+00 true resid norm 4.277033775892e-09 ||r(i)||/||b|| 4.078860845245e-09 >> 1 KSP unpreconditioned resid norm 2.831146511164e-10 true resid norm 2.831146511142e-10 ||r(i)||/||b|| 1.035195312725e-08 >> 1 2r: 1.31E-02 2x: 3.70E+09 2u: 3.66E+02 ir: 9.77E-03 iu: 6.03E+01 rsn: stol >> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 >> >> >> >> SNES_view: >> >> >> SNES Object: (flow_) 2 MPI processes >> type: newtonls >> maximum iterations=8, maximum function evaluations=10000 >> tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 >> total number of linear solver iterations=1 >> total number of function evaluations=2 >> norm schedule ALWAYS >> SNESLineSearch Object: (flow_) 2 MPI processes >> type: basic >> maxstep=1.000000e+08, minlambda=1.000000e-05 >> tolerances: relative=1.000000e-08, absolute=1.000000e-15, lambda=1.000000e-08 >> maximum iterations=40 >> using user-defined precheck step >> KSP Object: (flow_) 2 MPI processes >> type: fgmres >> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >> GMRES: happy breakdown tolerance 1e-30 >> maximum iterations=200, initial guess is zero >> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >> right preconditioning >> using UNPRECONDITIONED norm type for convergence test >> PC Object: (flow_) 2 MPI processes >> type: composite >> Composite PC type - MULTIPLICATIVE >> PCs on composite preconditioner follow >> --------------------------------- >> PC Object: (flow_sub_0_) 2 MPI processes >> type: galerkin >> Galerkin PC >> KSP on Galerkin follow >> --------------------------------- >> KSP Object: (flow_sub_0_galerkin_) 2 MPI processes >> type: richardson >> Richardson: damping factor=1. >> maximum iterations=200, initial guess is zero >> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >> left preconditioning >> using PRECONDITIONED norm type for convergence test >> PC Object: (flow_sub_0_galerkin_) 2 MPI processes >> type: hypre >> HYPRE BoomerAMG preconditioning >> HYPRE BoomerAMG: Cycle type V >> HYPRE BoomerAMG: Maximum number of levels 25 >> HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 >> HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. >> HYPRE BoomerAMG: Threshold for strong coupling 0.25 >> HYPRE BoomerAMG: Interpolation truncation factor 0. >> HYPRE BoomerAMG: Interpolation: max elements per row 0 >> HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 >> HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 >> HYPRE BoomerAMG: Maximum row sums 0.9 >> HYPRE BoomerAMG: Sweeps down 1 >> HYPRE BoomerAMG: Sweeps up 1 >> HYPRE BoomerAMG: Sweeps on coarse 1 >> HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi >> HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi >> HYPRE BoomerAMG: Relax on coarse Gaussian-elimination >> HYPRE BoomerAMG: Relax weight (all) 1. >> HYPRE BoomerAMG: Outer relax weight (all) 1. >> HYPRE BoomerAMG: Using CF-relaxation >> HYPRE BoomerAMG: Not using more complex smoothers. >> HYPRE BoomerAMG: Measure type local >> HYPRE BoomerAMG: Coarsen type Falgout >> HYPRE BoomerAMG: Interpolation type classical >> linear system matrix = precond matrix: >> Mat Object: 2 MPI processes >> type: mpiaij >> rows=8000, cols=8000 >> total: nonzeros=53600, allocated nonzeros=53600 >> total number of mallocs used during MatSetValues calls =0 >> not using I-node (on process 0) routines >> linear system matrix = precond matrix: >> Mat Object: (flow_) 2 MPI processes >> type: mpibaij >> rows=24000, cols=24000, bs=3 >> total: nonzeros=482400, allocated nonzeros=482400 >> total number of mallocs used during MatSetValues calls =0 >> PC Object: (flow_sub_1_) 2 MPI processes >> type: bjacobi >> block Jacobi: number of blocks = 2 >> Local solve is same for all blocks, in the following KSP and PC objects: >> KSP Object: (flow_sub_1_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: (flow_sub_1_sub_) 1 MPI processes >> type: lu >> out-of-place factorization >> tolerance for zero pivot 2.22045e-14 >> matrix ordering: nd >> factor fill ratio given 5., needed 18.3108 >> Factored matrix follows: >> Mat Object: 1 MPI processes >> type: seqbaij >> rows=12000, cols=12000, bs=3 >> package used to perform factorization: petsc >> total: nonzeros=4350654, allocated nonzeros=4350654 >> total number of mallocs used during MatSetValues calls =0 >> block size is 3 >> linear system matrix = precond matrix: >> Mat Object: (flow_) 1 MPI processes >> type: seqbaij >> rows=12000, cols=12000, bs=3 >> total: nonzeros=237600, allocated nonzeros=237600 >> total number of mallocs used during MatSetValues calls =0 >> block size is 3 >> linear system matrix = precond matrix: >> Mat Object: (flow_) 2 MPI processes >> type: mpibaij >> rows=24000, cols=24000, bs=3 >> total: nonzeros=482400, allocated nonzeros=482400 >> total number of mallocs used during MatSetValues calls =0 >> --------------------------------- >> linear system matrix = precond matrix: >> Mat Object: (flow_) 2 MPI processes >> type: mpibaij >> rows=24000, cols=24000, bs=3 >> total: nonzeros=482400, allocated nonzeros=482400 >> total number of mallocs used during MatSetValues calls =0 >> >> >> >> Is there a way to improve on the AMG part? Do I have to adjust the tolerances (make the inner tighter)? Which Hypre AMG parameters are worth tuning? This problem occurs for 1 MPI process as well, and solving the problem in Standard PFLOTRAN (i.e. Block Jacobi + ILU) is without any issue. >> >> Grateful for any help! >> Robert >> >> >> -------------- next part -------------- An HTML attachment was scrubbed... URL: From franck.houssen at inria.fr Wed Jul 5 03:26:46 2017 From: franck.houssen at inria.fr (Franck Houssen) Date: Wed, 5 Jul 2017 10:26:46 +0200 (CEST) Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <54F3F9BA-DD4E-46B9-91C9-3850293DFE18@mcs.anl.gov> References: <1946888301.20170703154737@man.poznan.pl> <1734368881.20170703162317@man.poznan.pl> <1391189420.20170704111607@man.poznan.pl> <54F3F9BA-DD4E-46B9-91C9-3850293DFE18@mcs.anl.gov> Message-ID: <598570767.14110609.1499243206559.JavaMail.zimbra@inria.fr> The man page of slurm/sbatch is cumbersome. But, you may think of : 1. tasks "as MPI processus" 2. cpus "as threads" You should always set resources the most precise way when possible, that is (never use --tasks but prefer) to: 1. use --nodes=n. 2. use --tasks-per-node=t. 3. use --cpus-per-tasks=c. 4. for a start, make sure that t*c = number of cores you have per node. 5. use --exclusive unless you may have VERY different timing if you run twice the same job. 6. make sure mpi is configured correctly (run twice [or more] the same mono-thread application: get the same timing ?) 7. if using OpenMP or multithread applications, make sure you have set affinity properly (GOMP_CPU_AFFINITY whith gnu, KMP_AFFINITY with intel). 8. make sure you have enough memory (--mem) unless performance may be degraded (swap). The rule of thumb 4 may NOT be respected but if so, you need to be aware WHY you want to do that (for KNL, it may [or not] make sense [depending on cache modes]). Remember than any multi-threaded (OpenMP or not) application may be victim of false sharing (https://en.wikipedia.org/wiki/False_sharing): in this case, profile (using cache metrics) may help to understand if this is the problem, and track it if so (you may use perf-record for that). Understanding HW is not an easy thing: you really need to go step by step unless you have no chance to understand anything in the end. Hope this may help !... Franck Note: activating/deactivating hyper-threading (if available - generally in BIOS when possible) may also change performances. ----- Mail original ----- > De: "Barry Smith" > ?: "Damian Kaliszan" > Cc: "PETSc" > Envoy?: Mardi 4 Juillet 2017 19:04:36 > Objet: Re: [petsc-users] Is OpenMP still available for PETSc? > > > You may need to ask a slurm expert. I have no idea what cpus-per-task > means > > > > On Jul 4, 2017, at 4:16 AM, Damian Kaliszan wrote: > > > > Hi, > > > > Yes, this is exactly what I meant. > > Please find attached output for 2 input datasets and for 2 various slurm > > configs each: > > > > A/ Matrix size=8000000x8000000 > > > > 1/ slurm-14432809.out, 930 ksp steps, ~90 secs > > > > > > #SBATCH --nodes=2 > > #SBATCH --ntasks=32 > > #SBATCH --ntasks-per-node=16 > > #SBATCH --cpus-per-task=4 > > > > 2/ slurm-14432810.out , 100.000 ksp steps, ~9700 secs > > > > #SBATCH --nodes=2 > > #SBATCH --ntasks=32 > > #SBATCH --ntasks-per-node=16 > > #SBATCH --cpus-per-task=2 > > > > > > > > B/ Matrix size=1000x1000 > > > > 1/ slurm-23716.out, 511 ksp steps, ~ 28 secs > > #SBATCH --nodes=1 > > #SBATCH --ntasks=64 > > #SBATCH --ntasks-per-node=64 > > #SBATCH --cpus-per-task=4 > > > > > > 2/ slurm-23718.out, 94 ksp steps, ~ 4 secs > > > > #SBATCH --nodes=1 > > #SBATCH --ntasks=4 > > #SBATCH --ntasks-per-node=4 > > #SBATCH --cpus-per-task=4 > > > > > > I would really appreciate any help...:) > > > > Best, > > Damian > > > > > > > > W li?cie datowanym 3 lipca 2017 (16:29:15) napisano: > > > > > > On Mon, Jul 3, 2017 at 9:23 AM, Damian Kaliszan > > wrote: > > Hi, > > > > > > >> 1) You can call Bcast on PETSC_COMM_WORLD > > > > To be honest I can't find Bcast method in petsc4py.PETSc.Comm (I'm > > using petsc4py) > > > > >> 2) If you are using WORLD, the number of iterates will be the same on > > >> each process since iteration is collective. > > > > Yes, this is how it should be. But what I noticed is that for > > different --cpus-per-task numbers in slurm script I get different > > number of solver iterations which is in turn related to timings. The > > imparity is huge. For example for some configurations where > > --cpus-per-task=1 I receive 900 > > iterations and for --cpus-per-task=2 I receive valid number of 100.000 > > which is set as max > > iter number set when setting solver tolerances. > > > > I am trying to understand what you are saying. You mean that you make 2 > > different runs and get a different > > number of iterates with a KSP? In order to answer questions about > > convergence, we need to see the output > > of > > > > -ksp_view -ksp_monitor_true_residual -ksp_converged_reason > > > > for all cases. > > > > Thanks, > > > > Matt > > > > Best, > > Damian > > > > > > > > > > -- > > What most experimenters take for granted before they begin their > > experiments is infinitely more interesting than any results to which their > > experiments lead. > > -- Norbert Wiener > > > > http://www.caam.rice.edu/~mk51/ > > > > > > > > > > > > ------------------------------------------------------- > > Damian Kaliszan > > > > Poznan Supercomputing and Networking Center > > HPC and Data Centres Technologies > > ul. Jana Paw?a II 10 > > 61-139 Poznan > > POLAND > > > > phone (+48 61) 858 5109 > > e-mail damian at man.poznan.pl > > www - http://www.man.poznan.pl/ > > ------------------------------------------------------- > > > > From damian at man.poznan.pl Wed Jul 5 03:45:34 2017 From: damian at man.poznan.pl (Damian Kaliszan) Date: Wed, 5 Jul 2017 10:45:34 +0200 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <598570767.14110609.1499243206559.JavaMail.zimbra@inria.fr> References: <1946888301.20170703154737@man.poznan.pl> <1734368881.20170703162317@man.poznan.pl> <1391189420.20170704111607@man.poznan.pl> <54F3F9BA-DD4E-46B9-91C9-3850293DFE18@mcs.anl.gov> <598570767.14110609.1499243206559.JavaMail.zimbra@inria.fr> Message-ID: <547420733.20170705104534@man.poznan.pl> Thank you:) Few notes on what you wrote 1. I always try to keep t*c=number of cores, however for 64 core KNL which has hyperthreading switched on (cpuinfo shows 256 cores) t*c should be 64 or 256 (in other words: is t=64 and c=4 correct?) ? 2. I noticed that for the same input data I may get different timings in 2 cases a) different number of ksp iterations are observed (why they differ?) -> please see screenshot Julia_N_10_4_vs_64.JPG for the following config (this may be related to 64*4 issue + which one is correct from first glance?): Matrix size=1000x1000 1/ slurm-23716.out, 511 steps, ~ 28 secs #SBATCH --nodes=1 #SBATCH --ntasks=64 #SBATCH --ntasks-per-node=64 #SBATCH --cpus-per-task=4 2/ slurm-23718.out, 94 steps, ~ 4 secs #SBATCH --nodes=1 #SBATCH --ntasks=4 #SBATCH --ntasks-per-node=4 #SBATCH --cpus-per-task=4 b) equal number of ksp iterations are observed but different timings (this might be due to false sharing or oversubscription ?) please see Julia_N_10_64_vs_64.JPG screenshot Best, Damian W li?cie datowanym 5 lipca 2017 (10:26:46) napisano: > The man page of slurm/sbatch is cumbersome. > But, you may think of : > 1. tasks "as MPI processus" > 2. cpus "as threads" > You should always set resources the most precise way when possible, > that is (never use --tasks but prefer) to: > 1. use --nodes=n. > 2. use --tasks-per-node=t. > 3. use --cpus-per-tasks=c. > 4. for a start, make sure that t*c = number of cores you have per node. > 5. use --exclusive unless you may have VERY different timing if you run twice the same job. > 6. make sure mpi is configured correctly (run twice [or more] the > same mono-thread application: get the same timing ?) > 7. if using OpenMP or multithread applications, make sure you have > set affinity properly (GOMP_CPU_AFFINITY whith gnu, KMP_AFFINITY with intel). > 8. make sure you have enough memory (--mem) unless performance may be degraded (swap). > The rule of thumb 4 may NOT be respected but if so, you need to be > aware WHY you want to do that (for KNL, it may [or not] make sense [depending on cache modes]). > Remember than any multi-threaded (OpenMP or not) application may be > victim of false sharing > (https://en.wikipedia.org/wiki/False_sharing): in this case, profile > (using cache metrics) may help to understand if this is the problem, > and track it if so (you may use perf-record for that). > Understanding HW is not an easy thing: you really need to go step > by step unless you have no chance to understand anything in the end. > Hope this may help !... > Franck > Note: activating/deactivating hyper-threading (if available - > generally in BIOS when possible) may also change performances. > ----- Mail original ----- >> De: "Barry Smith" >> ?: "Damian Kaliszan" >> Cc: "PETSc" >> Envoy?: Mardi 4 Juillet 2017 19:04:36 >> Objet: Re: [petsc-users] Is OpenMP still available for PETSc? >> >> >> ? ?You may need to ask a slurm expert. I have no idea what cpus-per-task >> ? ?means >> >> >> > On Jul 4, 2017, at 4:16 AM, Damian Kaliszan wrote: >> > >> > Hi, >> > >> > Yes, this is exactly what I meant. >> > Please find attached output for 2 input datasets and for 2 various slurm >> > configs each: >> > >> > A/ Matrix size=8000000x8000000 >> > >> > 1/ slurm-14432809.out, ? 930 ksp steps, ~90 secs >> > >> > >> > #SBATCH --nodes=2 >> > #SBATCH --ntasks=32 >> > #SBATCH --ntasks-per-node=16 >> > #SBATCH --cpus-per-task=4 >> > >> > 2/ ?slurm-14432810.out , 100.000 ksp steps, ~9700 secs >> > >> > #SBATCH --nodes=2 >> > #SBATCH --ntasks=32 >> > #SBATCH --ntasks-per-node=16 >> > #SBATCH --cpus-per-task=2 >> > >> > >> > >> > B/ Matrix size=1000x1000 >> > >> > 1/ ?slurm-23716.out, 511 ksp steps, ~ 28 secs >> > #SBATCH --nodes=1 >> > #SBATCH --ntasks=64 >> > #SBATCH --ntasks-per-node=64 >> > #SBATCH --cpus-per-task=4 >> > >> > >> > 2/ slurm-23718.out, 94 ksp steps, ~ 4 secs >> > >> > #SBATCH --nodes=1 >> > #SBATCH --ntasks=4 >> > #SBATCH --ntasks-per-node=4 >> > #SBATCH --cpus-per-task=4 >> > >> > >> > I would really appreciate any help...:) >> > >> > Best, >> > Damian >> > >> > >> > >> > W li?cie datowanym 3 lipca 2017 (16:29:15) napisano: >> > >> > >> > On Mon, Jul 3, 2017 at 9:23 AM, Damian Kaliszan >> > wrote: >> > Hi, >> > >> > >> > >> 1) You can call Bcast on PETSC_COMM_WORLD >> > >> > To ?be ?honest ?I ?can't find Bcast method in petsc4py.PETSc.Comm (I'm >> > using petsc4py) >> > >> > >> 2) If you are using WORLD, the number of iterates will be the same on >> > >> each process since iteration is collective. >> > >> > Yes, ?this ?is ?how ?it ?should ?be. ?But ?what ?I noticed is that for >> > different ?--cpus-per-task ?numbers ?in ?slurm ?script I get different >> > number ?of ?solver iterations which is in turn related to timings. The >> > imparity ? ?is ? ?huge. ?For ?example ?for ? some configurations where >> > --cpus-per-task=1 I receive 900 >> > iterations and ?for --cpus-per-task=2 I receive valid number of 100.000 >> > which is set as max >> > iter number set when setting solver tolerances. >> > >> > I am trying to understand what you are saying. You mean that you make 2 >> > different runs and get a different >> > number of iterates with a KSP? In order to answer questions about >> > convergence, we need to see the output >> > of >> > >> > -ksp_view -ksp_monitor_true_residual -ksp_converged_reason >> > >> > for all cases. >> > >> > Thanks, >> > >> > ? ?Matt >> > >> > Best, >> > Damian >> > >> > >> > >> > >> > -- >> > What most experimenters take for granted before they begin their >> > experiments is infinitely more interesting than any results to which their >> > experiments lead. >> > -- Norbert Wiener >> > >> > http://www.caam.rice.edu/~mk51/ >> > >> > >> > >> > >> > >> > ------------------------------------------------------- >> > Damian Kaliszan >> > >> > Poznan Supercomputing and Networking Center >> > HPC and Data Centres Technologies >> > ul. Jana Paw?a II 10 >> > 61-139 Poznan >> > POLAND >> > >> > phone (+48 61) 858 5109 >> > e-mail damian at man.poznan.pl >> > www - http://www.man.poznan.pl/ >> > ------------------------------------------------------- >> > >> >> ------------------------------------------------------- Damian Kaliszan Poznan Supercomputing and Networking Center HPC and Data Centres Technologies ul. Jana Paw?a II 10 61-139 Poznan POLAND phone (+48 61) 858 5109 e-mail damian at man.poznan.pl www - http://www.man.poznan.pl/ ------------------------------------------------------- From damian at man.poznan.pl Wed Jul 5 03:49:23 2017 From: damian at man.poznan.pl (Damian Kaliszan) Date: Wed, 5 Jul 2017 10:49:23 +0200 Subject: [petsc-users] Is OpenMP still available for PETSc? Message-ID: <1082287367.20170705104923@man.poznan.pl> Thank you:) Few notes on what you wrote 1. I always try to keep t*c=number of cores, however for 64 core KNL which has hyperthreading switched on (cpuinfo shows 256 cores) t*c should be 64 or 256 (in other words: is t=64 and c=4 correct?) ? 2. I noticed that for the same input data I may get different timings in 2 cases a) different number of ksp iterations are observed (why they differ?) -> please see screenshot Julia_N_10_4_vs_64.JPG for the following config (this may be related to 64*4 issue + which one is correct from first glance?): Matrix size=1000x1000 1/ slurm-23716.out, 511 steps, ~ 28 secs #SBATCH --nodes=1 #SBATCH --ntasks=64 #SBATCH --ntasks-per-node=64 #SBATCH --cpus-per-task=4 2/ slurm-23718.out, 94 steps, ~ 4 secs #SBATCH --nodes=1 #SBATCH --ntasks=4 #SBATCH --ntasks-per-node=4 #SBATCH --cpus-per-task=4 b) equal number of ksp iterations are observed but different timings (this might be due to false sharing or oversubscription ?) please see Julia_N_10_64_vs_64.JPG screenshot Best, Damian W lis?cie datowanym 5 lipca 2017 (10:26:46) napisano: > The man page of slurm/sbatch is cumbersome. > But, you may think of : > 1. tasks "as MPI processus" > 2. cpus "as threads" > You should always set resources the most precise way when possible, > that is (never use --tasks but prefer) to: > 1. use --nodes=n. > 2. use --tasks-per-node=t. > 3. use --cpus-per-tasks=c. > 4. for a start, make sure that t*c = number of cores you have per node. > 5. use --exclusive unless you may have VERY different timing if you run twice the same job. > 6. make sure mpi is configured correctly (run twice [or more] the > same mono-thread application: get the same timing ?) > 7. if using OpenMP or multithread applications, make sure you have > set affinity properly (GOMP_CPU_AFFINITY whith gnu, KMP_AFFINITY with intel). > 8. make sure you have enough memory (--mem) unless performance may be degraded (swap). > The rule of thumb 4 may NOT be respected but if so, you need to be > aware WHY you want to do that (for KNL, it may [or not] make sense [depending on cache modes]). > Remember than any multi-threaded (OpenMP or not) application may be > victim of false sharing > (https://en.wikipedia.org/wiki/False_sharing): in this case, profile > (using cache metrics) may help to understand if this is the problem, > and track it if so (you may use perf-record for that). > Understanding HW is not an easy thing: you really need to go step > by step unless you have no chance to understand anything in the end. > Hope this may help !... > Franck > Note: activating/deactivating hyper-threading (if available - > generally in BIOS when possible) may also change performances. > ----- Mail original ----- >> De: "Barry Smith" >> ?: "Damian Kaliszan" >> Cc: "PETSc" >> Envoy?: Mardi 4 Juillet 2017 19:04:36 >> Objet: Re: [petsc-users] Is OpenMP still available for PETSc? >> >> >> ? ?You may need to ask a slurm expert. I have no idea what cpus-per-task >> ? ?means >> >> >> > On Jul 4, 2017, at 4:16 AM, Damian Kaliszan wrote: >> > >> > Hi, >> > >> > Yes, this is exactly what I meant. >> > Please find attached output for 2 input datasets and for 2 various slurm >> > configs each: >> > >> > A/ Matrix size=8000000x8000000 >> > >> > 1/ slurm-14432809.out, ? 930 ksp steps, ~90 secs >> > >> > >> > #SBATCH --nodes=2 >> > #SBATCH --ntasks=32 >> > #SBATCH --ntasks-per-node=16 >> > #SBATCH --cpus-per-task=4 >> > >> > 2/ ?slurm-14432810.out , 100.000 ksp steps, ~9700 secs >> > >> > #SBATCH --nodes=2 >> > #SBATCH --ntasks=32 >> > #SBATCH --ntasks-per-node=16 >> > #SBATCH --cpus-per-task=2 >> > >> > >> > >> > B/ Matrix size=1000x1000 >> > >> > 1/ ?slurm-23716.out, 511 ksp steps, ~ 28 secs >> > #SBATCH --nodes=1 >> > #SBATCH --ntasks=64 >> > #SBATCH --ntasks-per-node=64 >> > #SBATCH --cpus-per-task=4 >> > >> > >> > 2/ slurm-23718.out, 94 ksp steps, ~ 4 secs >> > >> > #SBATCH --nodes=1 >> > #SBATCH --ntasks=4 >> > #SBATCH --ntasks-per-node=4 >> > #SBATCH --cpus-per-task=4 >> > >> > >> > I would really appreciate any help...:) >> > >> > Best, >> > Damian >> > >> > >> > >> > W lis?cie datowanym 3 lipca 2017 (16:29:15) napisano: >> > >> > >> > On Mon, Jul 3, 2017 at 9:23 AM, Damian Kaliszan >> > wrote: >> > Hi, >> > >> > >> > >> 1) You can call Bcast on PETSC_COMM_WORLD >> > >> > To ?be ?honest ?I ?can't find Bcast method in petsc4py.PETSc.Comm (I'm >> > using petsc4py) >> > >> > >> 2) If you are using WORLD, the number of iterates will be the same on >> > >> each process since iteration is collective. >> > >> > Yes, ?this ?is ?how ?it ?should ?be. ?But ?what ?I noticed is that for >> > different ?--cpus-per-task ?numbers ?in ?slurm ?script I get different >> > number ?of ?solver iterations which is in turn related to timings. The >> > imparity ? ?is ? ?huge. ?For ?example ?for ? some configurations where >> > --cpus-per-task=1 I receive 900 >> > iterations and ?for --cpus-per-task=2 I receive valid number of 100.000 >> > which is set as max >> > iter number set when setting solver tolerances. >> > >> > I am trying to understand what you are saying. You mean that you make 2 >> > different runs and get a different >> > number of iterates with a KSP? In order to answer questions about >> > convergence, we need to see the output >> > of >> > >> > -ksp_view -ksp_monitor_true_residual -ksp_converged_reason >> > >> > for all cases. >> > >> > Thanks, >> > >> > ? ?Matt >> > >> > Best, >> > Damian >> > >> > >> > >> > >> > -- >> > What most experimenters take for granted before they begin their >> > experiments is infinitely more interesting than any results to which their >> > experiments lead. >> > -- Norbert Wiener >> > >> > http://www.caam.rice.edu/~mk51/ >> > >> > >> > >> > >> > From damian at man.poznan.pl Wed Jul 5 03:50:39 2017 From: damian at man.poznan.pl (Damian Kaliszan) Date: Wed, 5 Jul 2017 10:50:39 +0200 Subject: [petsc-users] Is OpenMP still available for PETSc? Message-ID: <499285109.20170705105039@man.poznan.pl> Thank you:) Few notes on what you wrote 1. I always try to keep t*c=number of cores, however for 64 core KNL which has hyperthreading switched on (cpuinfo shows 256 cores) t*c should be 64 or 256 (in other words: is t=64 and c=4 correct?) ? 2. I noticed that for the same input data I may get different timings in 2 cases a) different number of ksp iterations are observed (why they differ?) -> please see screenshot Julia_N_10_4_vs_64.JPG for the following config (this may be related to 64*4 issue + which one is correct from first glance?): Matrix size=1000x1000 1/ slurm-23716.out, 511 steps, ~ 28 secs #SBATCH --nodes=1 #SBATCH --ntasks=64 #SBATCH --ntasks-per-node=64 #SBATCH --cpus-per-task=4 2/ slurm-23718.out, 94 steps, ~ 4 secs #SBATCH --nodes=1 #SBATCH --ntasks=4 #SBATCH --ntasks-per-node=4 #SBATCH --cpus-per-task=4 b) equal number of ksp iterations are observed but different timings (this might be due to false sharing or oversubscription ?) please see Julia_N_10_64_vs_64.JPG screenshot Best, Damian W li?cie datowanym 5 lipca 2017 (10:26:46) napisano: > The man page of slurm/sbatch is cumbersome. > But, you may think of : > 1. tasks "as MPI processus" > 2. cpus "as threads" > You should always set resources the most precise way when possible, > that is (never use --tasks but prefer) to: > 1. use --nodes=n. > 2. use --tasks-per-node=t. > 3. use --cpus-per-tasks=c. > 4. for a start, make sure that t*c = number of cores you have per node. > 5. use --exclusive unless you may have VERY different timing if you run twice the same job. > 6. make sure mpi is configured correctly (run twice [or more] the > same mono-thread application: get the same timing ?) > 7. if using OpenMP or multithread applications, make sure you have > set affinity properly (GOMP_CPU_AFFINITY whith gnu, KMP_AFFINITY with intel). > 8. make sure you have enough memory (--mem) unless performance may be degraded (swap). > The rule of thumb 4 may NOT be respected but if so, you need to be > aware WHY you want to do that (for KNL, it may [or not] make sense [depending on cache modes]). > Remember than any multi-threaded (OpenMP or not) application may be > victim of false sharing > (https://en.wikipedia.org/wiki/False_sharing): in this case, profile > (using cache metrics) may help to understand if this is the problem, > and track it if so (you may use perf-record for that). > Understanding HW is not an easy thing: you really need to go step > by step unless you have no chance to understand anything in the end. > Hope this may help !... > Franck > Note: activating/deactivating hyper-threading (if available - > generally in BIOS when possible) may also change performances. > ----- Mail original ----- >> De: "Barry Smith" >> ?: "Damian Kaliszan" >> Cc: "PETSc" >> Envoy?: Mardi 4 Juillet 2017 19:04:36 >> Objet: Re: [petsc-users] Is OpenMP still available for PETSc? >> >> >> ? ?You may need to ask a slurm expert. I have no idea what cpus-per-task >> ? ?means >> >> >> > On Jul 4, 2017, at 4:16 AM, Damian Kaliszan wrote: >> > >> > Hi, >> > >> > Yes, this is exactly what I meant. >> > Please find attached output for 2 input datasets and for 2 various slurm >> > configs each: >> > >> > A/ Matrix size=8000000x8000000 >> > >> > 1/ slurm-14432809.out, ? 930 ksp steps, ~90 secs >> > >> > >> > #SBATCH --nodes=2 >> > #SBATCH --ntasks=32 >> > #SBATCH --ntasks-per-node=16 >> > #SBATCH --cpus-per-task=4 >> > >> > 2/ ?slurm-14432810.out , 100.000 ksp steps, ~9700 secs >> > >> > #SBATCH --nodes=2 >> > #SBATCH --ntasks=32 >> > #SBATCH --ntasks-per-node=16 >> > #SBATCH --cpus-per-task=2 >> > >> > >> > >> > B/ Matrix size=1000x1000 >> > >> > 1/ ?slurm-23716.out, 511 ksp steps, ~ 28 secs >> > #SBATCH --nodes=1 >> > #SBATCH --ntasks=64 >> > #SBATCH --ntasks-per-node=64 >> > #SBATCH --cpus-per-task=4 >> > >> > >> > 2/ slurm-23718.out, 94 ksp steps, ~ 4 secs >> > >> > #SBATCH --nodes=1 >> > #SBATCH --ntasks=4 >> > #SBATCH --ntasks-per-node=4 >> > #SBATCH --cpus-per-task=4 >> > >> > >> > I would really appreciate any help...:) >> > >> > Best, >> > Damian >> > >> > >> > >> > W li?cie datowanym 3 lipca 2017 (16:29:15) napisano: >> > >> > >> > On Mon, Jul 3, 2017 at 9:23 AM, Damian Kaliszan >> > wrote: >> > Hi, >> > >> > >> > >> 1) You can call Bcast on PETSC_COMM_WORLD >> > >> > To ?be ?honest ?I ?can't find Bcast method in petsc4py.PETSc.Comm (I'm >> > using petsc4py) >> > >> > >> 2) If you are using WORLD, the number of iterates will be the same on >> > >> each process since iteration is collective. >> > >> > Yes, ?this ?is ?how ?it ?should ?be. ?But ?what ?I noticed is that for >> > different ?--cpus-per-task ?numbers ?in ?slurm ?script I get different >> > number ?of ?solver iterations which is in turn related to timings. The >> > imparity ? ?is ? ?huge. ?For ?example ?for ? some configurations where >> > --cpus-per-task=1 I receive 900 >> > iterations and ?for --cpus-per-task=2 I receive valid number of 100.000 >> > which is set as max >> > iter number set when setting solver tolerances. >> > >> > I am trying to understand what you are saying. You mean that you make 2 >> > different runs and get a different >> > number of iterates with a KSP? In order to answer questions about >> > convergence, we need to see the output >> > of >> > >> > -ksp_view -ksp_monitor_true_residual -ksp_converged_reason >> > >> > for all cases. >> > >> > Thanks, >> > >> > ? ?Matt >> > >> > Best, >> > Damian >> > >> > >> > >> > >> > -- >> > What most experimenters take for granted before they begin their >> > experiments is infinitely more interesting than any results to which their >> > experiments lead. >> > -- Norbert Wiener >> > >> > http://www.caam.rice.edu/~mk51/ >> > >> > >> > >> > >> > >> > ------------------------------------------------------- >> > Damian Kaliszan >> > >> > Poznan Supercomputing and Networking Center >> > HPC and Data Centres Technologies >> > ul. Jana Paw?a II 10 >> > 61-139 Poznan >> > POLAND >> > >> > phone (+48 61) 858 5109 >> > e-mail damian at man.poznan.pl >> > www - http://www.man.poznan.pl/ >> > ------------------------------------------------------- >> > >> >> -------------- next part -------------- A non-text attachment was scrubbed... Name: Julia_N_10_4_vs_64.JPG Type: image/jpeg Size: 296317 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: Julia_N_10_64_vs_64.JPG Type: image/jpeg Size: 256918 bytes Desc: not available URL: From franck.houssen at inria.fr Wed Jul 5 08:09:59 2017 From: franck.houssen at inria.fr (Franck Houssen) Date: Wed, 5 Jul 2017 15:09:59 +0200 (CEST) Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <499285109.20170705105039@man.poznan.pl> References: <499285109.20170705105039@man.poznan.pl> Message-ID: <729693129.14259406.1499260199676.JavaMail.zimbra@inria.fr> For a given use case, you may want to try all possible t and c such that t*c=n : stick to the best one. Now, if you modify resources (t/c) and you get different timing/iterations, this seems logical to me: blocks, overlap, ... (and finally convergence) will differ so comparison does no more really make sense as you do something different (unless you fix t, and let c vary: even like that, you may not get what you expect - anyway, seems it's not what you do). Franck ----- Mail original ----- > De: "Damian Kaliszan" > ?: "Franck Houssen" , "Barry Smith" > Cc: petsc-users at mcs.anl.gov > Envoy?: Mercredi 5 Juillet 2017 10:50:39 > Objet: Re: [petsc-users] Is OpenMP still available for PETSc? > > Thank you:) > > Few notes on what you wrote > 1. I always try to keep t*c=number of cores, however for 64 core KNL > which has hyperthreading switched on (cpuinfo shows 256 cores) t*c > should be 64 or 256 (in other words: is t=64 and c=4 correct?) ? > 2. I noticed that for the same input data I may get different > timings in 2 cases > a) different number of ksp iterations are observed (why they differ?) > -> please see screenshot Julia_N_10_4_vs_64.JPG for the following > config (this may be > related to 64*4 issue + which one is correct from first glance?): > > Matrix size=1000x1000 > > 1/ slurm-23716.out, 511 steps, ~ 28 secs > #SBATCH --nodes=1 > #SBATCH --ntasks=64 > #SBATCH --ntasks-per-node=64 > #SBATCH --cpus-per-task=4 > > > 2/ slurm-23718.out, 94 steps, ~ 4 secs > > #SBATCH --nodes=1 > #SBATCH --ntasks=4 > #SBATCH --ntasks-per-node=4 > #SBATCH --cpus-per-task=4 > > b) equal number of ksp iterations are observed but different timings > (this might be > due to false sharing or oversubscription ?) > please see Julia_N_10_64_vs_64.JPG screenshot > > > > Best, > Damian > > W li?cie datowanym 5 lipca 2017 (10:26:46) napisano: > > > The man page of slurm/sbatch is cumbersome. > > > But, you may think of : > > 1. tasks "as MPI processus" > > 2. cpus "as threads" > > > You should always set resources the most precise way when possible, > > that is (never use --tasks but prefer) to: > > 1. use --nodes=n. > > 2. use --tasks-per-node=t. > > 3. use --cpus-per-tasks=c. > > 4. for a start, make sure that t*c = number of cores you have per node. > > 5. use --exclusive unless you may have VERY different timing if you run > > twice the same job. > > 6. make sure mpi is configured correctly (run twice [or more] the > > same mono-thread application: get the same timing ?) > > 7. if using OpenMP or multithread applications, make sure you have > > set affinity properly (GOMP_CPU_AFFINITY whith gnu, KMP_AFFINITY with > > intel). > > 8. make sure you have enough memory (--mem) unless performance may be > > degraded (swap). > > > The rule of thumb 4 may NOT be respected but if so, you need to be > > aware WHY you want to do that (for KNL, it may [or not] make sense > > [depending on cache modes]). > > > Remember than any multi-threaded (OpenMP or not) application may be > > victim of false sharing > > (https://en.wikipedia.org/wiki/False_sharing): in this case, profile > > (using cache metrics) may help to understand if this is the problem, > > and track it if so (you may use perf-record for that). > > > Understanding HW is not an easy thing: you really need to go step > > by step unless you have no chance to understand anything in the end. > > > Hope this may help !... > > > Franck > > > Note: activating/deactivating hyper-threading (if available - > > generally in BIOS when possible) may also change performances. > > > ----- Mail original ----- > >> De: "Barry Smith" > >> ?: "Damian Kaliszan" > >> Cc: "PETSc" > >> Envoy?: Mardi 4 Juillet 2017 19:04:36 > >> Objet: Re: [petsc-users] Is OpenMP still available for PETSc? > >> > >> > >> ? ?You may need to ask a slurm expert. I have no idea what cpus-per-task > >> ? ?means > >> > >> > >> > On Jul 4, 2017, at 4:16 AM, Damian Kaliszan > >> > wrote: > >> > > >> > Hi, > >> > > >> > Yes, this is exactly what I meant. > >> > Please find attached output for 2 input datasets and for 2 various slurm > >> > configs each: > >> > > >> > A/ Matrix size=8000000x8000000 > >> > > >> > 1/ slurm-14432809.out, ? 930 ksp steps, ~90 secs > >> > > >> > > >> > #SBATCH --nodes=2 > >> > #SBATCH --ntasks=32 > >> > #SBATCH --ntasks-per-node=16 > >> > #SBATCH --cpus-per-task=4 > >> > > >> > 2/ ?slurm-14432810.out , 100.000 ksp steps, ~9700 secs > >> > > >> > #SBATCH --nodes=2 > >> > #SBATCH --ntasks=32 > >> > #SBATCH --ntasks-per-node=16 > >> > #SBATCH --cpus-per-task=2 > >> > > >> > > >> > > >> > B/ Matrix size=1000x1000 > >> > > >> > 1/ ?slurm-23716.out, 511 ksp steps, ~ 28 secs > >> > #SBATCH --nodes=1 > >> > #SBATCH --ntasks=64 > >> > #SBATCH --ntasks-per-node=64 > >> > #SBATCH --cpus-per-task=4 > >> > > >> > > >> > 2/ slurm-23718.out, 94 ksp steps, ~ 4 secs > >> > > >> > #SBATCH --nodes=1 > >> > #SBATCH --ntasks=4 > >> > #SBATCH --ntasks-per-node=4 > >> > #SBATCH --cpus-per-task=4 > >> > > >> > > >> > I would really appreciate any help...:) > >> > > >> > Best, > >> > Damian > >> > > >> > > >> > > >> > W li?cie datowanym 3 lipca 2017 (16:29:15) napisano: > >> > > >> > > >> > On Mon, Jul 3, 2017 at 9:23 AM, Damian Kaliszan > >> > wrote: > >> > Hi, > >> > > >> > > >> > >> 1) You can call Bcast on PETSC_COMM_WORLD > >> > > >> > To ?be ?honest ?I ?can't find Bcast method in petsc4py.PETSc.Comm (I'm > >> > using petsc4py) > >> > > >> > >> 2) If you are using WORLD, the number of iterates will be the same on > >> > >> each process since iteration is collective. > >> > > >> > Yes, ?this ?is ?how ?it ?should ?be. ?But ?what ?I noticed is that for > >> > different ?--cpus-per-task ?numbers ?in ?slurm ?script I get different > >> > number ?of ?solver iterations which is in turn related to timings. The > >> > imparity ? ?is ? ?huge. ?For ?example ?for ? some configurations where > >> > --cpus-per-task=1 I receive 900 > >> > iterations and ?for --cpus-per-task=2 I receive valid number of 100.000 > >> > which is set as max > >> > iter number set when setting solver tolerances. > >> > > >> > I am trying to understand what you are saying. You mean that you make 2 > >> > different runs and get a different > >> > number of iterates with a KSP? In order to answer questions about > >> > convergence, we need to see the output > >> > of > >> > > >> > -ksp_view -ksp_monitor_true_residual -ksp_converged_reason > >> > > >> > for all cases. > >> > > >> > Thanks, > >> > > >> > ? ?Matt > >> > > >> > Best, > >> > Damian > >> > > >> > > >> > > >> > > >> > -- > >> > What most experimenters take for granted before they begin their > >> > experiments is infinitely more interesting than any results to which > >> > their > >> > experiments lead. > >> > -- Norbert Wiener > >> > > >> > http://www.caam.rice.edu/~mk51/ > >> > > >> > > >> > > >> > > >> > > >> > ------------------------------------------------------- > >> > Damian Kaliszan > >> > > >> > Poznan Supercomputing and Networking Center > >> > HPC and Data Centres Technologies > >> > ul. Jana Paw?a II 10 > >> > 61-139 Poznan > >> > POLAND > >> > > >> > phone (+48 61) 858 5109 > >> > e-mail damian at man.poznan.pl > >> > www - http://www.man.poznan.pl/ > >> > ------------------------------------------------------- > >> > > >> > >> From imilian.hartig at gmail.com Wed Jul 5 11:24:03 2017 From: imilian.hartig at gmail.com (Maximilian Hartig) Date: Wed, 5 Jul 2017 18:24:03 +0200 Subject: [petsc-users] -snes_fd for problems with residuals with non-continuous first derivative? In-Reply-To: References: Message-ID: The solver goes on for some timesteps, then it gets hung up in step 10. The output is as follows: 28 SNES Function norm 7.825649542035e-06 0 KSP preconditioned resid norm 5.335581451751e+00 true resid norm 7.825649542035e-06 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.875747966342e-13 true resid norm 3.082821236889e-15 ||r(i)||/||b|| 3.939380648635e-10 Linear solve converged due to CONVERGED_RTOL iterations 1 29 SNES Function norm 7.825641650401e-06 0 KSP preconditioned resid norm 5.335568660325e+00 true resid norm 7.825641650401e-06 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.169064646930e-13 true resid norm 2.949237553452e-15 ||r(i)||/||b|| 3.768684646199e-10 Linear solve converged due to CONVERGED_RTOL iterations 1 30 SNES Function norm 7.825633758775e-06 0 KSP preconditioned resid norm 5.335575714181e+00 true resid norm 7.825633758775e-06 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.626528075820e-13 true resid norm 7.454935467844e-16 ||r(i)||/||b|| 9.526302530432e-11 Linear solve converged due to CONVERGED_RTOL iterations 1 31 SNES Function norm 7.825625867144e-06 0 KSP preconditioned resid norm 5.335574289757e+00 true resid norm 7.825625867144e-06 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.220021201426e-13 true resid norm 6.140701297052e-16 ||r(i)||/||b|| 7.846913973787e-11 Linear solve converged due to CONVERGED_RTOL iterations 1 32 SNES Function norm 7.825617975525e-06 0 KSP preconditioned resid norm 5.335556211708e+00 true resid norm 7.825617975525e-06 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 3.238615954344e-14 true resid norm 1.639170816829e-15 ||r(i)||/||b|| 2.094621564655e-10 Linear solve converged due to CONVERGED_RTOL iterations 1 33 SNES Function norm 7.825610083913e-06 0 KSP preconditioned resid norm 5.335545135100e+00 true resid norm 7.825610083913e-06 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 8.328043430360e-14 true resid norm 7.902728010647e-16 ||r(i)||/||b|| 1.009854557780e-10 Linear solve converged due to CONVERGED_RTOL iterations 1 34 SNES Function norm 7.825609294752e-06 0 KSP preconditioned resid norm 5.335519330054e+00 true resid norm 7.825609294752e-06 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 1.176339150741e-13 true resid norm 2.137240765649e-15 ||r(i)||/||b|| 2.731085446703e-10 Linear solve converged due to CONVERGED_RTOL iterations 1 35 SNES Function norm 7.825608505592e-06 0 KSP preconditioned resid norm 5.335552250936e+00 true resid norm 7.825608505592e-06 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.388837462586e-13 true resid norm 3.899327292367e-16 ||r(i)||/||b|| 4.982778386601e-11 Linear solve converged due to CONVERGED_RTOL iterations 1 36 SNES Function norm 7.825607716432e-06 0 KSP preconditioned resid norm 1.017554264638e-01 true resid norm 7.825607716432e-06 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.758703070887e-14 true resid norm 1.990491888342e-16 ||r(i)||/||b|| 2.543562059932e-11 Linear solve converged due to CONVERGED_RTOL iterations 1 37 SNES Function norm 3.815837655573e-08 0 KSP preconditioned resid norm 7.197730150406e+00 true resid norm 3.815837655573e-08 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 7.114599045039e-12 true resid norm 4.763264085142e-16 ||r(i)||/||b|| 1.248287929175e-08 Linear solve converged due to CONVERGED_RTOL iterations 1 38 SNES Function norm 3.790245121284e-08 0 KSP preconditioned resid norm 7.127517791828e+00 true resid norm 3.790245121284e-08 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.500976336448e-11 true resid norm 1.692661771456e-15 ||r(i)||/||b|| 4.465837214461e-08 Linear solve converged due to CONVERGED_RTOL iterations 1 39 SNES Function norm 3.758101652998e-08 0 KSP preconditioned resid norm 1.931834799209e-02 true resid norm 3.758101652998e-08 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 5.958979968059e-16 true resid norm 2.588244438237e-18 ||r(i)||/||b|| 6.887105983875e-11 Linear solve converged due to CONVERGED_RTOL iterations 1 Nonlinear solve did not converge due to DIVERGED_FUNCTION_COUNT iterations 39 [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: [0]PETSC ERROR: TSStep has failed due to DIVERGED_NONLINEAR_SOLVE, increase -ts_max_snes_failures or make negative to attempt recovery [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. [0]PETSC ERROR: Petsc Development GIT revision: v3.7.5-3342-gb122798 GIT Date: 2017-03-22 17:42:51 -0500 [0]PETSC ERROR: ./miniFEM on a arch-linux2-c-debug named iket127138 by hartig Wed Jul 5 18:09:53 2017 [0]PETSC ERROR: Configure options PETSC_ARCH=arch-linux2-c-debug --with-cc=mpigcc --with-cxx=mpicxx --with-fc=mpif90 --download-ml --download-parmetis --download-metis --download-hypre --download-mumps --download-scalapack [0]PETSC ERROR: #1 TSStep() line 3818 in /home/hartig/petsc/src/ts/interface/ts.c [0]PETSC ERROR: #2 TSSolve() line 4054 in /home/hartig/petsc/src/ts/interface/ts.c [0]PETSC ERROR: #3 main() line 1829 in /home/hartig/Nextcloud/Dissertation/Code/Debugging/miniFEM.c [0]PETSC ERROR: PETSc Option Table entries: [0]PETSC ERROR: -def_petscspace_order 2 [0]PETSC ERROR: -eplast_petscspace_order 2 [0]PETSC ERROR: -ksp_converged_reason [0]PETSC ERROR: -ksp_monitor_true_residual [0]PETSC ERROR: -pc_type lu [0]PETSC ERROR: -plast [0]PETSC ERROR: -snes_converged_reason [0]PETSC ERROR: -snes_fd [0]PETSC ERROR: -snes_monitor [0]PETSC ERROR: -snes_type newtonls [0]PETSC ERROR: -ts_monitor [0]PETSC ERROR: -vel_petscspace_order 2 [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- Thanks, Max 2017-06-30 17:14 GMT+02:00 Barry Smith : > > What is the output from > > -snes_monitor -ksp_monitor_true_residual -pc_type lu > -ksp_converged_reason -snes_converged_reason > > > > On Jun 30, 2017, at 3:45 AM, Maximilian Hartig > wrote: > > > > Hello, > > > > I?m trying to implement plasticity and have problems getting the Petsc > SNES to converge. To check if my residual formulation is correct I tried > running with -snes_fd for an easy example as the Petsc FAQ suggest. I > cannot seem to get the solver to converge at any cost. > > I already tried to impose bounds on the solution and moved to > vinewtonrsls as a nonlinear solver. I checked and rechecked my residuals > but I do not find an error there. I now have the suspicion that the > -snes_fd option is not made for handling residuals who?s first derivatives > are not continuous (e.g. have an ?if? condition in them for the plasticity/ > flow-condition). Can you confirm my suspicion? And is there another way to > test my residual formulation separate from my hand-coded jacobian? > > > > > > Thanks, > > Max > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From s_g at berkeley.edu Wed Jul 5 11:30:21 2017 From: s_g at berkeley.edu (Sanjay Govindjee) Date: Wed, 5 Jul 2017 09:30:21 -0700 Subject: [petsc-users] -snes_fd for problems with residuals with non-continuous first derivative? In-Reply-To: References: Message-ID: <61cecc8a-e622-a688-f588-3dc1fb161deb@berkeley.edu> Plasticity should not cause any major difficulties with your global iterations. Your residuals look your load steps are elastic all the way until it fails. Are you sure that your applied boundary conditions have a unique solutions? In particular, are you applying forces to a perfect plasticity problem that are leading to gross plastic flow? Perhaps try applying driving displacement boundary conditions. -sg On 7/5/17 9:24 AM, Maximilian Hartig wrote: > The solver goes on for some timesteps, then it gets hung up in step > 10. The output is as follows: > > 28 SNES Function norm 7.825649542035e-06 > 0 KSP preconditioned resid norm 5.335581451751e+00 true resid > norm 7.825649542035e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.875747966342e-13 true resid > norm 3.082821236889e-15 ||r(i)||/||b|| 3.939380648635e-10 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 29 SNES Function norm 7.825641650401e-06 > 0 KSP preconditioned resid norm 5.335568660325e+00 true resid > norm 7.825641650401e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.169064646930e-13 true resid > norm 2.949237553452e-15 ||r(i)||/||b|| 3.768684646199e-10 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 30 SNES Function norm 7.825633758775e-06 > 0 KSP preconditioned resid norm 5.335575714181e+00 true resid > norm 7.825633758775e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.626528075820e-13 true resid > norm 7.454935467844e-16 ||r(i)||/||b|| 9.526302530432e-11 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 31 SNES Function norm 7.825625867144e-06 > 0 KSP preconditioned resid norm 5.335574289757e+00 true resid > norm 7.825625867144e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.220021201426e-13 true resid > norm 6.140701297052e-16 ||r(i)||/||b|| 7.846913973787e-11 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 32 SNES Function norm 7.825617975525e-06 > 0 KSP preconditioned resid norm 5.335556211708e+00 true resid > norm 7.825617975525e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.238615954344e-14 true resid > norm 1.639170816829e-15 ||r(i)||/||b|| 2.094621564655e-10 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 33 SNES Function norm 7.825610083913e-06 > 0 KSP preconditioned resid norm 5.335545135100e+00 true resid > norm 7.825610083913e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 8.328043430360e-14 true resid > norm 7.902728010647e-16 ||r(i)||/||b|| 1.009854557780e-10 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 34 SNES Function norm 7.825609294752e-06 > 0 KSP preconditioned resid norm 5.335519330054e+00 true resid > norm 7.825609294752e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.176339150741e-13 true resid > norm 2.137240765649e-15 ||r(i)||/||b|| 2.731085446703e-10 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 35 SNES Function norm 7.825608505592e-06 > 0 KSP preconditioned resid norm 5.335552250936e+00 true resid > norm 7.825608505592e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.388837462586e-13 true resid > norm 3.899327292367e-16 ||r(i)||/||b|| 4.982778386601e-11 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 36 SNES Function norm 7.825607716432e-06 > 0 KSP preconditioned resid norm 1.017554264638e-01 true resid > norm 7.825607716432e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.758703070887e-14 true resid > norm 1.990491888342e-16 ||r(i)||/||b|| 2.543562059932e-11 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 37 SNES Function norm 3.815837655573e-08 > 0 KSP preconditioned resid norm 7.197730150406e+00 true resid > norm 3.815837655573e-08 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.114599045039e-12 true resid > norm 4.763264085142e-16 ||r(i)||/||b|| 1.248287929175e-08 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 38 SNES Function norm 3.790245121284e-08 > 0 KSP preconditioned resid norm 7.127517791828e+00 true resid > norm 3.790245121284e-08 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.500976336448e-11 true resid > norm 1.692661771456e-15 ||r(i)||/||b|| 4.465837214461e-08 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 39 SNES Function norm 3.758101652998e-08 > 0 KSP preconditioned resid norm 1.931834799209e-02 true resid > norm 3.758101652998e-08 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.958979968059e-16 true resid > norm 2.588244438237e-18 ||r(i)||/||b|| 6.887105983875e-11 > Linear solve converged due to CONVERGED_RTOL iterations 1 > Nonlinear solve did not converge due to DIVERGED_FUNCTION_COUNT > iterations 39 > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > [0]PETSC ERROR: > [0]PETSC ERROR: TSStep has failed due to DIVERGED_NONLINEAR_SOLVE, > increase -ts_max_snes_failures or make negative to attempt recovery > [0]PETSC ERROR: See > http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.7.5-3342-gb122798 > GIT Date: 2017-03-22 17:42:51 -0500 > [0]PETSC ERROR: ./miniFEM on a arch-linux2-c-debug named iket127138 by > hartig Wed Jul 5 18:09:53 2017 > [0]PETSC ERROR: Configure options PETSC_ARCH=arch-linux2-c-debug > --with-cc=mpigcc --with-cxx=mpicxx --with-fc=mpif90 --download-ml > --download-parmetis --download-metis --download-hypre --download-mumps > --download-scalapack > [0]PETSC ERROR: #1 TSStep() line 3818 in > /home/hartig/petsc/src/ts/interface/ts.c > [0]PETSC ERROR: #2 TSSolve() line 4054 in > /home/hartig/petsc/src/ts/interface/ts.c > [0]PETSC ERROR: #3 main() line 1829 in > /home/hartig/Nextcloud/Dissertation/Code/Debugging/miniFEM.c > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: -def_petscspace_order 2 > [0]PETSC ERROR: -eplast_petscspace_order 2 > [0]PETSC ERROR: -ksp_converged_reason > [0]PETSC ERROR: -ksp_monitor_true_residual > [0]PETSC ERROR: -pc_type lu > [0]PETSC ERROR: -plast > [0]PETSC ERROR: -snes_converged_reason > [0]PETSC ERROR: -snes_fd > [0]PETSC ERROR: -snes_monitor > [0]PETSC ERROR: -snes_type newtonls > [0]PETSC ERROR: -ts_monitor > [0]PETSC ERROR: -vel_petscspace_order 2 > [0]PETSC ERROR: ----------------End of Error Message -------send > entire error message to petsc-maint at mcs.anl.gov---------- > > > Thanks, > Max > > > 2017-06-30 17:14 GMT+02:00 Barry Smith >: > > > What is the output from > > -snes_monitor -ksp_monitor_true_residual -pc_type lu > -ksp_converged_reason -snes_converged_reason > > > > On Jun 30, 2017, at 3:45 AM, Maximilian Hartig > > wrote: > > > > Hello, > > > > I?m trying to implement plasticity and have problems getting the > Petsc SNES to converge. To check if my residual formulation is > correct I tried running with -snes_fd for an easy example as the > Petsc FAQ suggest. I cannot seem to get the solver to converge at > any cost. > > I already tried to impose bounds on the solution and moved to > vinewtonrsls as a nonlinear solver. I checked and rechecked my > residuals but I do not find an error there. I now have the > suspicion that the -snes_fd option is not made for handling > residuals who?s first derivatives are not continuous (e.g. have an > ?if? condition in them for the plasticity/ flow-condition). Can > you confirm my suspicion? And is there another way to test my > residual formulation separate from my hand-coded jacobian? > > > > > > Thanks, > > Max > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From imilian.hartig at gmail.com Wed Jul 5 11:39:31 2017 From: imilian.hartig at gmail.com (Maximilian Hartig) Date: Wed, 5 Jul 2017 18:39:31 +0200 Subject: [petsc-users] -snes_fd for problems with residuals with non-continuous first derivative? In-Reply-To: References: <87978294-9B3A-46C3-9986-6CA2B90891FD@gmail.com> Message-ID: I do not clearly understand the discrimination between local and global plasticity. I do have areas where I expect the behaviour to be elastic and other areas where I expect elasto-plastic behaviour. Inertia effects are of importance and hence I need second order temporal derivatives of my displacements. The only way I have found to implement this in Petsc is to create a separate velocity field which I use to then compute ?. To account for plasticity, in my understanding I need to introduce at least one additional history variable. In my case this is the effective plastic strain e_p. I then solve the equation of motion (grad(sigma)-rho*?+F=0) and the consistency condition (sigma_eq - sigma_yield = 0) at the same time. Or try to at least. Thanks, Max 2017-06-30 20:49 GMT+02:00 Luv Sharma : > Hi Max, > > I do not understand the equations that you write very clearly. > > Are you looking to implement a ?local? and ?if? type of isotropic > hardening plasticity? If that is the case, then in my understanding you > need to solve only 1 field equation for the displacement components or for > the strain components. You can look at the following code: > https://github.com/tdegeus/GooseFFT/blob/master/small- > strain/laminate/elasto-plasticity.py > > If you are looking for a PETSc based implementation for plasticity > (isotropic/anisotropic) you can look at > https://damask.mpie.de/ > I had presented a talk about the same at the PETSc User Meeting last year. > > As I understand it, additional field equations will only be necessary if > the plasticity or elasticity were ?nonlocal?. You may want to look at: > On the role of moving elastic?plastic boundaries in strain gradient > plasticity, R H J Peerlings > > Best regards, > Luv > > On 30 Jun 2017, at 11:52, Maximilian Hartig > wrote: > > Hi Luv, > > I?m modelling linear hardening(sigma_y = sigma_y0 + > K_iso*epsilon_plast_eqiv) with isotropic plasticity only. So I should not > need to use an iterative method to find the point on the yield surface. I > have three fields and 7 unknowns in total: > Field 0: 3 displacement components > Field 1: 3 velocity components > Field 2: 1 equivalent plastic strain > > It is the solver for these three fields that is not converging. I am using > PetscFE. As residuals for the plastic case (sigma_vM > sigma_yield) I have: > > Field 0 (displacement): > f0[i] = rho*u_t[u_Off[1]+i] > f1[i*dim+j] = sigma_tr[i*dim+j] - 2*mu*sqrt(3/2)*u_t[uOff[2]]*N[i*dim+j] > > where sigma_tr is the trial stress, mu is the shear modulus and N is the > unit deviator tensor normal to the yield surface. > > Field 1 (velocity): > f0[i] = u[uOff[1]+i]-u_t[i] > f1[i*dim+j] = 0 > > Field 2 (effective plastic strain): > f0[0] = ||s_tr|| -2*mu*sqrt(3/2)*u_t[uOff[2]]-sqrt(2/3)*sigma_y > f1[i] = 0 > where ||s_tr|| is the norm of the deviator stress tensor. > > Field 0 residual is essentially newton?s second law of motion and Field 2 > residual should be the yield criterion. I might have just fundamentally > misunderstood the equations of plasticity but I cannot seem to find my > mistake. > > Thanks, > Max > > > On 30. Jun 2017, at 11:09, Luv Sharma wrote: > > Hi Max, > > Is your field solver not converging or the material point solver ;)? > > Best regards, > Luv > > On 30 Jun 2017, at 10:45, Maximilian Hartig > wrote: > > Hello, > > I?m trying to implement plasticity and have problems getting the Petsc > SNES to converge. To check if my residual formulation is correct I tried > running with -snes_fd for an easy example as the Petsc FAQ suggest. I > cannot seem to get the solver to converge at any cost. > I already tried to impose bounds on the solution and moved to vinewtonrsls > as a nonlinear solver. I checked and rechecked my residuals but I do not > find an error there. I now have the suspicion that the -snes_fd option is > not made for handling residuals who?s first derivatives are not continuous > (e.g. have an ?if? condition in them for the plasticity/ flow-condition). > Can you confirm my suspicion? And is there another way to test my residual > formulation separate from my hand-coded jacobian? > > > Thanks, > Max > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Wed Jul 5 11:46:18 2017 From: knepley at gmail.com (Matthew Knepley) Date: Wed, 5 Jul 2017 09:46:18 -0700 Subject: [petsc-users] -snes_fd for problems with residuals with non-continuous first derivative? In-Reply-To: References: <87978294-9B3A-46C3-9986-6CA2B90891FD@gmail.com> Message-ID: On Wed, Jul 5, 2017 at 9:39 AM, Maximilian Hartig wrote: > I do not clearly understand the discrimination between local and global > plasticity. I do have areas where I expect the behaviour to be elastic and > other areas where I expect elasto-plastic behaviour. > Inertia effects are of importance and hence I need second order temporal > derivatives of my displacements. The only way I have found to implement > this in Petsc is to create a separate velocity field which I use to then > compute ?. > We do have one second order timestepper (Newmark) put in by Lisandro: http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/TS/TSALPHA2.html > To account for plasticity, in my understanding I need to introduce at > least one additional history variable. In my case this is the effective > plastic strain e_p. I then solve the equation of motion > (grad(sigma)-rho*?+F=0) and the consistency condition (sigma_eq - > sigma_yield = 0) at the same time. Or try to at least. > Did you look at the DAMASK formulation that Luv suggested? Thanks, Matt > Thanks, > Max > > 2017-06-30 20:49 GMT+02:00 Luv Sharma : > >> Hi Max, >> >> I do not understand the equations that you write very clearly. >> >> Are you looking to implement a ?local? and ?if? type of isotropic >> hardening plasticity? If that is the case, then in my understanding you >> need to solve only 1 field equation for the displacement components or for >> the strain components. You can look at the following code: >> https://github.com/tdegeus/GooseFFT/blob/master/small-strain >> /laminate/elasto-plasticity.py >> >> If you are looking for a PETSc based implementation for plasticity >> (isotropic/anisotropic) you can look at >> https://damask.mpie.de/ >> I had presented a talk about the same at the PETSc User Meeting last year. >> >> As I understand it, additional field equations will only be necessary if >> the plasticity or elasticity were ?nonlocal?. You may want to look at: >> On the role of moving elastic?plastic boundaries in strain gradient >> plasticity, R H J Peerlings >> >> Best regards, >> Luv >> >> On 30 Jun 2017, at 11:52, Maximilian Hartig >> wrote: >> >> Hi Luv, >> >> I?m modelling linear hardening(sigma_y = sigma_y0 + >> K_iso*epsilon_plast_eqiv) with isotropic plasticity only. So I should not >> need to use an iterative method to find the point on the yield surface. I >> have three fields and 7 unknowns in total: >> Field 0: 3 displacement components >> Field 1: 3 velocity components >> Field 2: 1 equivalent plastic strain >> >> It is the solver for these three fields that is not converging. I am >> using PetscFE. As residuals for the plastic case (sigma_vM > sigma_yield) I >> have: >> >> Field 0 (displacement): >> f0[i] = rho*u_t[u_Off[1]+i] >> f1[i*dim+j] = sigma_tr[i*dim+j] - 2*mu*sqrt(3/2)*u_t[uOff[2]]*N[i*dim+j] >> >> where sigma_tr is the trial stress, mu is the shear modulus and N is the >> unit deviator tensor normal to the yield surface. >> >> Field 1 (velocity): >> f0[i] = u[uOff[1]+i]-u_t[i] >> f1[i*dim+j] = 0 >> >> Field 2 (effective plastic strain): >> f0[0] = ||s_tr|| -2*mu*sqrt(3/2)*u_t[uOff[2]]-sqrt(2/3)*sigma_y >> f1[i] = 0 >> where ||s_tr|| is the norm of the deviator stress tensor. >> >> Field 0 residual is essentially newton?s second law of motion and Field 2 >> residual should be the yield criterion. I might have just fundamentally >> misunderstood the equations of plasticity but I cannot seem to find my >> mistake. >> >> Thanks, >> Max >> >> >> On 30. Jun 2017, at 11:09, Luv Sharma wrote: >> >> Hi Max, >> >> Is your field solver not converging or the material point solver ;)? >> >> Best regards, >> Luv >> >> On 30 Jun 2017, at 10:45, Maximilian Hartig >> wrote: >> >> Hello, >> >> I?m trying to implement plasticity and have problems getting the Petsc >> SNES to converge. To check if my residual formulation is correct I tried >> running with -snes_fd for an easy example as the Petsc FAQ suggest. I >> cannot seem to get the solver to converge at any cost. >> I already tried to impose bounds on the solution and moved to >> vinewtonrsls as a nonlinear solver. I checked and rechecked my residuals >> but I do not find an error there. I now have the suspicion that the >> -snes_fd option is not made for handling residuals who?s first derivatives >> are not continuous (e.g. have an ?if? condition in them for the plasticity/ >> flow-condition). Can you confirm my suspicion? And is there another way to >> test my residual formulation separate from my hand-coded jacobian? >> >> >> Thanks, >> Max >> >> >> >> >> > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From s_g at berkeley.edu Wed Jul 5 12:08:24 2017 From: s_g at berkeley.edu (Sanjay Govindjee) Date: Wed, 5 Jul 2017 10:08:24 -0700 Subject: [petsc-users] -snes_fd for problems with residuals with non-continuous first derivative? In-Reply-To: References: <87978294-9B3A-46C3-9986-6CA2B90891FD@gmail.com> Message-ID: <02c4a0fc-534e-0e4b-6955-8edfb0b85dda@berkeley.edu> Let me suggest that you grab a hold of Simo and Hughes, Computational Inelasticity, Springer-Verlag (1998). It explains a lot about how to set up this problem -- in particular Chapter 1 gives a comprehensive one-dimensional tutorial on everything you need to know. On 7/5/17 9:39 AM, Maximilian Hartig wrote: > I do not clearly understand the discrimination between local and > global plasticity. I do have areas where I expect the behaviour to be > elastic and other areas where I expect elasto-plastic behaviour. > Inertia effects are of importance and hence I need second order > temporal derivatives of my displacements. The only way I have found to > implement this in Petsc is to create a separate velocity field which I > use to then compute ?. > To account for plasticity, in my understanding I need to introduce at > least one additional history variable. In my case this is the > effective plastic strain e_p. I then solve the equation of motion > (grad(sigma)-rho*?+F=0) and the consistency condition (sigma_eq - > sigma_yield = 0) at the same time. Or try to at least. > > Thanks, > Max > > 2017-06-30 20:49 GMT+02:00 Luv Sharma >: > > Hi Max, > > I do not understand the equations that you write very clearly. > > Are you looking to implement a ?local? and ?if? type of isotropic > hardening plasticity? If that is the case, then in my > understanding you need to solve only 1 field equation for the > displacement components or for the strain components. You can look > at the following code: > https://github.com/tdegeus/GooseFFT/blob/master/small-strain/laminate/elasto-plasticity.py > > > If you are looking for a PETSc based implementation for plasticity > (isotropic/anisotropic) you can look at > https://damask.mpie.de/ > I had presented a talk about the same at the PETSc User Meeting > last year. > > As I understand it, additional field equations will only be > necessary if the plasticity or elasticity were ?nonlocal?. You may > want to look at: > On the role of moving elastic?plastic boundaries in strain > gradient plasticity, R H J Peerlings > > Best regards, > Luv > >> On 30 Jun 2017, at 11:52, Maximilian Hartig >> > wrote: >> >> Hi Luv, >> >> I?m modelling linear hardening(sigma_y = sigma_y0 + >> K_iso*epsilon_plast_eqiv) with isotropic plasticity only. So I >> should not need to use an iterative method to find the point on >> the yield surface. I have three fields and 7 unknowns in total: >> Field 0: 3 displacement components >> Field 1: 3 velocity components >> Field 2: 1 equivalent plastic strain >> >> It is the solver for these three fields that is not converging. I >> am using PetscFE. As residuals for the plastic case (sigma_vM > >> sigma_yield) I have: >> >> Field 0 (displacement): >> f0[i] = rho*u_t[u_Off[1]+i] >> f1[i*dim+j] = sigma_tr[i*dim+j] - >> 2*mu*sqrt(3/2)*u_t[uOff[2]]*N[i*dim+j] >> >> where sigma_tr is the trial stress, mu is the shear modulus and N >> is the unit deviator tensor normal to the yield surface. >> >> Field 1 (velocity): >> f0[i] = u[uOff[1]+i]-u_t[i] >> f1[i*dim+j] = 0 >> >> Field 2 (effective plastic strain): >> f0[0] = ||s_tr|| -2*mu*sqrt(3/2)*u_t[uOff[2]]-sqrt(2/3)*sigma_y >> f1[i] = 0 >> where ||s_tr|| is the norm of the deviator stress tensor. >> >> Field 0 residual is essentially newton?s second law of motion and >> Field 2 residual should be the yield criterion. I might have just >> fundamentally misunderstood the equations of plasticity but I >> cannot seem to find my mistake. >> >> Thanks, >> Max >> >> >>> On 30. Jun 2017, at 11:09, Luv Sharma >> > wrote: >>> >>> Hi Max, >>> >>> Is your field solver not converging or the material point solver >>> ;)? >>> >>> Best regards, >>> Luv >>>> On 30 Jun 2017, at 10:45, Maximilian Hartig >>>> > wrote: >>>> >>>> Hello, >>>> >>>> I?m trying to implement plasticity and have problems getting >>>> the Petsc SNES to converge. To check if my residual formulation >>>> is correct I tried running with -snes_fd for an easy example as >>>> the Petsc FAQ suggest. I cannot seem to get the solver to >>>> converge at any cost. >>>> I already tried to impose bounds on the solution and moved to >>>> vinewtonrsls as a nonlinear solver. I checked and rechecked my >>>> residuals but I do not find an error there. I now have the >>>> suspicion that the -snes_fd option is not made for handling >>>> residuals who?s first derivatives are not continuous (e.g. have >>>> an ?if? condition in them for the plasticity/ flow-condition). >>>> Can you confirm my suspicion? And is there another way to test >>>> my residual formulation separate from my hand-coded jacobian? >>>> >>>> >>>> Thanks, >>>> Max >>> >> > > -- ------------------------------------------------------------------- Sanjay Govindjee, PhD, PE Horace, Dorothy, and Katherine Johnson Professor in Engineering 779 Davis Hall University of California Berkeley, CA 94720-1710 Voice: +1 510 642 6060 FAX: +1 510 643 5264 s_g at berkeley.edu http://faculty.ce.berkeley.edu/sanjay ------------------------------------------------------------------- Books: Engineering Mechanics of Deformable Solids: A Presentation with Exercises http://www.oup.com/us/catalog/general/subject/Physics/MaterialsScience/?view=usa&ci=9780199651641 http://ukcatalogue.oup.com/product/9780199651641.do http://amzn.com/0199651647 Engineering Mechanics 3 (Dynamics) 2nd Edition http://www.springer.com/978-3-642-53711-0 http://amzn.com/3642537111 Engineering Mechanics 3, Supplementary Problems: Dynamics http://www.amzn.com/B00SOXN8JU ----------------------------------------------- -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Jul 5 13:24:00 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 5 Jul 2017 13:24:00 -0500 Subject: [petsc-users] -snes_fd for problems with residuals with non-continuous first derivative? In-Reply-To: References: Message-ID: <8EEBC84F-F0BB-4E7F-9FAA-8D35B86A15BC@mcs.anl.gov> > 39 SNES Function norm 3.758101652998e-08 > 0 KSP preconditioned resid norm 1.931834799209e-02 true resid norm 3.758101652998e-08 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.958979968059e-16 true resid norm 2.588244438237e-18 ||r(i)||/||b|| 6.887105983875e-11 The SNES function norm is pretty small here are you sure you need it smaller. > Nonlinear solve did not converge due to DIVERGED_FUNCTION_COUNT i You should just set the function count to say 1 billion so it doesn't stop the solution process. > On Jul 5, 2017, at 11:24 AM, Maximilian Hartig wrote: > > The solver goes on for some timesteps, then it gets hung up in step 10. The output is as follows: > > 28 SNES Function norm 7.825649542035e-06 > 0 KSP preconditioned resid norm 5.335581451751e+00 true resid norm 7.825649542035e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.875747966342e-13 true resid norm 3.082821236889e-15 ||r(i)||/||b|| 3.939380648635e-10 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 29 SNES Function norm 7.825641650401e-06 > 0 KSP preconditioned resid norm 5.335568660325e+00 true resid norm 7.825641650401e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.169064646930e-13 true resid norm 2.949237553452e-15 ||r(i)||/||b|| 3.768684646199e-10 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 30 SNES Function norm 7.825633758775e-06 > 0 KSP preconditioned resid norm 5.335575714181e+00 true resid norm 7.825633758775e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.626528075820e-13 true resid norm 7.454935467844e-16 ||r(i)||/||b|| 9.526302530432e-11 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 31 SNES Function norm 7.825625867144e-06 > 0 KSP preconditioned resid norm 5.335574289757e+00 true resid norm 7.825625867144e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.220021201426e-13 true resid norm 6.140701297052e-16 ||r(i)||/||b|| 7.846913973787e-11 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 32 SNES Function norm 7.825617975525e-06 > 0 KSP preconditioned resid norm 5.335556211708e+00 true resid norm 7.825617975525e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 3.238615954344e-14 true resid norm 1.639170816829e-15 ||r(i)||/||b|| 2.094621564655e-10 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 33 SNES Function norm 7.825610083913e-06 > 0 KSP preconditioned resid norm 5.335545135100e+00 true resid norm 7.825610083913e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 8.328043430360e-14 true resid norm 7.902728010647e-16 ||r(i)||/||b|| 1.009854557780e-10 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 34 SNES Function norm 7.825609294752e-06 > 0 KSP preconditioned resid norm 5.335519330054e+00 true resid norm 7.825609294752e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 1.176339150741e-13 true resid norm 2.137240765649e-15 ||r(i)||/||b|| 2.731085446703e-10 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 35 SNES Function norm 7.825608505592e-06 > 0 KSP preconditioned resid norm 5.335552250936e+00 true resid norm 7.825608505592e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.388837462586e-13 true resid norm 3.899327292367e-16 ||r(i)||/||b|| 4.982778386601e-11 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 36 SNES Function norm 7.825607716432e-06 > 0 KSP preconditioned resid norm 1.017554264638e-01 true resid norm 7.825607716432e-06 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.758703070887e-14 true resid norm 1.990491888342e-16 ||r(i)||/||b|| 2.543562059932e-11 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 37 SNES Function norm 3.815837655573e-08 > 0 KSP preconditioned resid norm 7.197730150406e+00 true resid norm 3.815837655573e-08 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.114599045039e-12 true resid norm 4.763264085142e-16 ||r(i)||/||b|| 1.248287929175e-08 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 38 SNES Function norm 3.790245121284e-08 > 0 KSP preconditioned resid norm 7.127517791828e+00 true resid norm 3.790245121284e-08 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.500976336448e-11 true resid norm 1.692661771456e-15 ||r(i)||/||b|| 4.465837214461e-08 > Linear solve converged due to CONVERGED_RTOL iterations 1 > 39 SNES Function norm 3.758101652998e-08 > 0 KSP preconditioned resid norm 1.931834799209e-02 true resid norm 3.758101652998e-08 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.958979968059e-16 true resid norm 2.588244438237e-18 ||r(i)||/||b|| 6.887105983875e-11 > Linear solve converged due to CONVERGED_RTOL iterations 1 > Nonlinear solve did not converge due to DIVERGED_FUNCTION_COUNT iterations 39 > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: > [0]PETSC ERROR: TSStep has failed due to DIVERGED_NONLINEAR_SOLVE, increase -ts_max_snes_failures or make negative to attempt recovery > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > [0]PETSC ERROR: Petsc Development GIT revision: v3.7.5-3342-gb122798 GIT Date: 2017-03-22 17:42:51 -0500 > [0]PETSC ERROR: ./miniFEM on a arch-linux2-c-debug named iket127138 by hartig Wed Jul 5 18:09:53 2017 > [0]PETSC ERROR: Configure options PETSC_ARCH=arch-linux2-c-debug --with-cc=mpigcc --with-cxx=mpicxx --with-fc=mpif90 --download-ml --download-parmetis --download-metis --download-hypre --download-mumps --download-scalapack > [0]PETSC ERROR: #1 TSStep() line 3818 in /home/hartig/petsc/src/ts/interface/ts.c > [0]PETSC ERROR: #2 TSSolve() line 4054 in /home/hartig/petsc/src/ts/interface/ts.c > [0]PETSC ERROR: #3 main() line 1829 in /home/hartig/Nextcloud/Dissertation/Code/Debugging/miniFEM.c > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: -def_petscspace_order 2 > [0]PETSC ERROR: -eplast_petscspace_order 2 > [0]PETSC ERROR: -ksp_converged_reason > [0]PETSC ERROR: -ksp_monitor_true_residual > [0]PETSC ERROR: -pc_type lu > [0]PETSC ERROR: -plast > [0]PETSC ERROR: -snes_converged_reason > [0]PETSC ERROR: -snes_fd > [0]PETSC ERROR: -snes_monitor > [0]PETSC ERROR: -snes_type newtonls > [0]PETSC ERROR: -ts_monitor > [0]PETSC ERROR: -vel_petscspace_order 2 > [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- > > > Thanks, > Max > > > 2017-06-30 17:14 GMT+02:00 Barry Smith : > > What is the output from > > -snes_monitor -ksp_monitor_true_residual -pc_type lu -ksp_converged_reason -snes_converged_reason > > > > On Jun 30, 2017, at 3:45 AM, Maximilian Hartig wrote: > > > > Hello, > > > > I?m trying to implement plasticity and have problems getting the Petsc SNES to converge. To check if my residual formulation is correct I tried running with -snes_fd for an easy example as the Petsc FAQ suggest. I cannot seem to get the solver to converge at any cost. > > I already tried to impose bounds on the solution and moved to vinewtonrsls as a nonlinear solver. I checked and rechecked my residuals but I do not find an error there. I now have the suspicion that the -snes_fd option is not made for handling residuals who?s first derivatives are not continuous (e.g. have an ?if? condition in them for the plasticity/ flow-condition). Can you confirm my suspicion? And is there another way to test my residual formulation separate from my hand-coded jacobian? > > > > > > Thanks, > > Max > > From damian at man.poznan.pl Thu Jul 6 02:56:58 2017 From: damian at man.poznan.pl (Damian Kaliszan) Date: Thu, 6 Jul 2017 09:56:58 +0200 Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <729693129.14259406.1499260199676.JavaMail.zimbra@inria.fr> References: <499285109.20170705105039@man.poznan.pl> <729693129.14259406.1499260199676.JavaMail.zimbra@inria.fr> Message-ID: <8310514853.20170706095658@man.poznan.pl> Dear Franck, Thank you for tour comment! Did I get you correctly: According to you may t<->c combination influence the the convergence -> ksp iterations -> timings (result array/vector should be identical though)? Best, Damian W li?cie datowanym 5 lipca 2017 (15:09:59) napisano: > For a given use case, you may want to try all possible t and c such > that t*c=n : stick to the best one. > Now, if you modify resources (t/c) and you get different > timing/iterations, this seems logical to me: blocks, overlap, ... > (and finally convergence) will differ so comparison does no more > really make sense as you do something different (unless you fix t, > and let c vary: even like that, you may not get what you expect - > anyway, seems it's not what you do). > Franck > ----- Mail original ----- >> De: "Damian Kaliszan" >> ?: "Franck Houssen" , "Barry Smith" >> Cc: petsc-users at mcs.anl.gov >> Envoy?: Mercredi 5 Juillet 2017 10:50:39 >> Objet: Re: [petsc-users] Is OpenMP still available for PETSc? >> >> Thank you:) >> >> Few notes on what you wrote >> 1. I ?always ?try to keep t*c=number of cores, however for 64 core KNL >> which ?has ?hyperthreading ?switched ?on (cpuinfo shows 256 cores) t*c >> should be 64 or 256 (in other words: is t=64 and c=4 correct?) ? >> 2. ?I ?noticed ?that ?for the same input data I may get different >> timings in 2 cases >> a) ?different ?number of ksp iterations are observed (why they differ?) >> ? ?-> ? please ?see ?screenshot ?Julia_N_10_4_vs_64.JPG for the following >> ? ?config (this may be >> ? ?related to 64*4 issue + which one is correct from first glance?): >> >> Matrix size=1000x1000 >> >> 1/ ?slurm-23716.out, 511 steps, ~ 28 secs >> #SBATCH --nodes=1 >> #SBATCH --ntasks=64 >> #SBATCH --ntasks-per-node=64 >> #SBATCH --cpus-per-task=4 >> >> >> 2/ slurm-23718.out, 94 steps, ~ 4 secs >> >> #SBATCH --nodes=1 >> #SBATCH --ntasks=4 >> #SBATCH --ntasks-per-node=4 >> #SBATCH --cpus-per-task=4 >> >> b) ?equal ?number ?of ksp iterations are observed but different timings >> (this might be >> due to false sharing or oversubscription ?) >> please see ? Julia_N_10_64_vs_64.JPG screenshot >> >> >> >> Best, >> Damian >> ? >> W li?cie datowanym 5 lipca 2017 (10:26:46) napisano: >> ? >> > The man page of slurm/sbatch is cumbersome. >> >> > But, you may think of : >> > 1. tasks "as MPI processus" >> > 2. cpus "as threads" >> >> > You should always set resources the most precise way when possible, >> > that is (never use --tasks but prefer) to: >> > 1. use --nodes=n. >> > 2. use --tasks-per-node=t. >> > 3. use --cpus-per-tasks=c. >> > 4. for a start, make sure that t*c = number of cores you have per node. >> > 5. use --exclusive unless you may have VERY different timing if you run >> > twice the same job. >> > 6. make sure mpi is configured correctly (run twice [or more] the >> > same mono-thread application: get the same timing ?) >> > 7. if using OpenMP or multithread applications, make sure you have >> > set affinity properly (GOMP_CPU_AFFINITY whith gnu, KMP_AFFINITY with >> > intel). >> > 8. make sure you have enough memory (--mem) unless performance may be >> > degraded (swap). >> >> > The rule of thumb 4 may NOT be respected but if so, you need to be >> > aware WHY you want to do that (for KNL, it may [or not] make sense >> > [depending on cache modes]). >> >> > Remember than any multi-threaded (OpenMP or not) application may be >> > victim of false sharing >> > (https://en.wikipedia.org/wiki/False_sharing): in this case, profile >> > (using cache metrics) may help to understand if this is the problem, >> > and track it if so (you may use perf-record for that). >> >> > Understanding HW is not an easy thing: you really need to go step >> > by step unless you have no chance to understand anything in the end. >> >> > Hope this may help !... >> >> > Franck >> >> > Note: activating/deactivating hyper-threading (if available - >> > generally in BIOS when possible) may also change performances. >> >> > ----- Mail original ----- >> >> De: "Barry Smith" >> >> ?: "Damian Kaliszan" >> >> Cc: "PETSc" >> >> Envoy?: Mardi 4 Juillet 2017 19:04:36 >> >> Objet: Re: [petsc-users] Is OpenMP still available for PETSc? >> >> >> >> >> >> You may need to ask a slurm expert. I have no idea what cpus-per-task >> >> means >> >> >> >> >> >> > On Jul 4, 2017, at 4:16 AM, Damian Kaliszan >> >> > wrote: >> >> > >> >> > Hi, >> >> > >> >> > Yes, this is exactly what I meant. >> >> > Please find attached output for 2 input datasets and for 2 various slurm >> >> > configs each: >> >> > >> >> > A/ Matrix size=8000000x8000000 >> >> > >> >> > 1/ slurm-14432809.out, 930 ksp steps, ~90 secs >> >> > >> >> > >> >> > #SBATCH --nodes=2 >> >> > #SBATCH --ntasks=32 >> >> > #SBATCH --ntasks-per-node=16 >> >> > #SBATCH --cpus-per-task=4 >> >> > >> >> > 2/ slurm-14432810.out , 100.000 ksp steps, ~9700 secs >> >> > >> >> > #SBATCH --nodes=2 >> >> > #SBATCH --ntasks=32 >> >> > #SBATCH --ntasks-per-node=16 >> >> > #SBATCH --cpus-per-task=2 >> >> > >> >> > >> >> > >> >> > B/ Matrix size=1000x1000 >> >> > >> >> > 1/ slurm-23716.out, 511 ksp steps, ~ 28 secs >> >> > #SBATCH --nodes=1 >> >> > #SBATCH --ntasks=64 >> >> > #SBATCH --ntasks-per-node=64 >> >> > #SBATCH --cpus-per-task=4 >> >> > >> >> > >> >> > 2/ slurm-23718.out, 94 ksp steps, ~ 4 secs >> >> > >> >> > #SBATCH --nodes=1 >> >> > #SBATCH --ntasks=4 >> >> > #SBATCH --ntasks-per-node=4 >> >> > #SBATCH --cpus-per-task=4 >> >> > >> >> > >> >> > I would really appreciate any help...:) >> >> > >> >> > Best, >> >> > Damian >> >> > >> >> > >> >> > >> >> > W li?cie datowanym 3 lipca 2017 (16:29:15) napisano: >> >> > >> >> > >> >> > On Mon, Jul 3, 2017 at 9:23 AM, Damian Kaliszan >> >> > wrote: >> >> > Hi, >> >> > >> >> > >> >> > >> 1) You can call Bcast on PETSC_COMM_WORLD >> >> > >> >> > To be honest I can't find Bcast method in petsc4py.PETSc.Comm (I'm >> >> > using petsc4py) >> >> > >> >> > >> 2) If you are using WORLD, the number of iterates will be the same on >> >> > >> each process since iteration is collective. >> >> > >> >> > Yes, this is how it should be. But what I noticed is that for >> >> > different --cpus-per-task numbers in slurm script I get different >> >> > number of solver iterations which is in turn related to timings. The >> >> > imparity is huge. For example for some configurations where >> >> > --cpus-per-task=1 I receive 900 >> >> > iterations and for --cpus-per-task=2 I receive valid number of 100.000 >> >> > which is set as max >> >> > iter number set when setting solver tolerances. >> >> > >> >> > I am trying to understand what you are saying. You mean that you make 2 >> >> > different runs and get a different >> >> > number of iterates with a KSP? In order to answer questions about >> >> > convergence, we need to see the output >> >> > of >> >> > >> >> > -ksp_view -ksp_monitor_true_residual -ksp_converged_reason >> >> > >> >> > for all cases. >> >> > >> >> > Thanks, >> >> > >> >> > Matt >> >> > >> >> > Best, >> >> > Damian >> >> > >> >> > >> >> > >> >> > >> >> > -- >> >> > What most experimenters take for granted before they begin their >> >> > experiments is infinitely more interesting than any results to which >> >> > their >> >> > experiments lead. >> >> > -- Norbert Wiener >> >> > >> >> > http://www.caam.rice.edu/~mk51/ >> >> > >> >> > >> >> > >> >> > >> >> > >> >> > ------------------------------------------------------- >> >> > Damian Kaliszan >> >> > >> >> > Poznan Supercomputing and Networking Center >> >> > HPC and Data Centres Technologies >> >> > ul. Jana Paw?a II 10 >> >> > 61-139 Poznan >> >> > POLAND >> >> > >> >> > phone (+48 61) 858 5109 >> >> > e-mail damian at man.poznan.pl >> >> > www - http://www.man.poznan.pl/ >> >> > ------------------------------------------------------- >> >> > >> >> >> >> From franck.houssen at inria.fr Thu Jul 6 07:23:59 2017 From: franck.houssen at inria.fr (Franck Houssen) Date: Thu, 6 Jul 2017 14:23:59 +0200 (CEST) Subject: [petsc-users] Is OpenMP still available for PETSc? In-Reply-To: <8310514853.20170706095658@man.poznan.pl> References: <499285109.20170705105039@man.poznan.pl> <729693129.14259406.1499260199676.JavaMail.zimbra@inria.fr> <8310514853.20170706095658@man.poznan.pl> Message-ID: <116320372.14731670.1499343839865.JavaMail.zimbra@inria.fr> I do NOT have an answer ! What I was trying to say is that, it WOULD be likely that each MPI proc gets some kind of "sub parts" (blocks - possibly overlapping ?) of the initial problem. Then, it WOULD be likely that each MPI proc has several threads to process each "sub part". These assumptions may be "not so true" (depending on pc, cases, methods, options, ...) or "just" wrong : I do NOT know how PETSc has been written ! Suppose the picture I assume is "not so far" from reality, then: 1. increasing t (= slurm tasks = nb of MPI procs) may change the problem (*), so you MAY (?) no more "really" compare (or you need to make SURE that the overlapping and other stuffs still allow comparison - not so obvious). 2. increasing c (= slurm cpus = nb of threads per MPI proc) SHOULD improve timings and possibly iterations (but you also may NOT get any improvement if threads go to a point where they are drowned, concurrent, victim of false sharing or any kind of other reasons...) To make it short: "to allow comparisons, first, I WOULD have fixed t, and then, I would have changed only c.... And I would NOT have been so surprised if speed-up would show up to be disappointing". I may be wrong. Franck (*) : changing t changes "sub parts" (blocks, borders of local "sub parts", overlapping, ....). My understanding is that whatever the method you use overlapping of blocks (however you name them according to methods, options, ...) "sizes" the informations that come from "neighbor proc" : my understanding is that this information is mandatory for good local convergence and may impact it (but I may be wrong) ----- Mail original ----- > De: "Damian Kaliszan" > ?: "Franck Houssen" > Cc: petsc-users at mcs.anl.gov > Envoy?: Jeudi 6 Juillet 2017 09:56:58 > Objet: Re: [petsc-users] Is OpenMP still available for PETSc? > > Dear Franck, > > Thank you for tour comment! > Did I get you correctly: According to you may t<->c combination > influence the the convergence -> ksp iterations -> timings (result > array/vector should be identical though)? > > Best, > Damian > > W li?cie datowanym 5 lipca 2017 (15:09:59) napisano: > > > For a given use case, you may want to try all possible t and c such > > that t*c=n : stick to the best one. > > > Now, if you modify resources (t/c) and you get different > > timing/iterations, this seems logical to me: blocks, overlap, ... > > (and finally convergence) will differ so comparison does no more > > really make sense as you do something different (unless you fix t, > > and let c vary: even like that, you may not get what you expect - > > anyway, seems it's not what you do). > > > Franck > > > ----- Mail original ----- > >> De: "Damian Kaliszan" > >> ?: "Franck Houssen" , "Barry Smith" > >> > >> Cc: petsc-users at mcs.anl.gov > >> Envoy?: Mercredi 5 Juillet 2017 10:50:39 > >> Objet: Re: [petsc-users] Is OpenMP still available for PETSc? > >> > >> Thank you:) > >> > >> Few notes on what you wrote > >> 1. I ?always ?try to keep t*c=number of cores, however for 64 core KNL > >> which ?has ?hyperthreading ?switched ?on (cpuinfo shows 256 cores) t*c > >> should be 64 or 256 (in other words: is t=64 and c=4 correct?) ? > >> 2. ?I ?noticed ?that ?for the same input data I may get different > >> timings in 2 cases > >> a) ?different ?number of ksp iterations are observed (why they differ?) > >> ? ?-> ? please ?see ?screenshot ?Julia_N_10_4_vs_64.JPG for the following > >> ? ?config (this may be > >> ? ?related to 64*4 issue + which one is correct from first glance?): > >> > >> Matrix size=1000x1000 > >> > >> 1/ ?slurm-23716.out, 511 steps, ~ 28 secs > >> #SBATCH --nodes=1 > >> #SBATCH --ntasks=64 > >> #SBATCH --ntasks-per-node=64 > >> #SBATCH --cpus-per-task=4 > >> > >> > >> 2/ slurm-23718.out, 94 steps, ~ 4 secs > >> > >> #SBATCH --nodes=1 > >> #SBATCH --ntasks=4 > >> #SBATCH --ntasks-per-node=4 > >> #SBATCH --cpus-per-task=4 > >> > >> b) ?equal ?number ?of ksp iterations are observed but different timings > >> (this might be > >> due to false sharing or oversubscription ?) > >> please see ? Julia_N_10_64_vs_64.JPG screenshot > >> > >> > >> > >> Best, > >> Damian > >> ? > >> W li?cie datowanym 5 lipca 2017 (10:26:46) napisano: > >> ? > >> > The man page of slurm/sbatch is cumbersome. > >> > >> > But, you may think of : > >> > 1. tasks "as MPI processus" > >> > 2. cpus "as threads" > >> > >> > You should always set resources the most precise way when possible, > >> > that is (never use --tasks but prefer) to: > >> > 1. use --nodes=n. > >> > 2. use --tasks-per-node=t. > >> > 3. use --cpus-per-tasks=c. > >> > 4. for a start, make sure that t*c = number of cores you have per node. > >> > 5. use --exclusive unless you may have VERY different timing if you run > >> > twice the same job. > >> > 6. make sure mpi is configured correctly (run twice [or more] the > >> > same mono-thread application: get the same timing ?) > >> > 7. if using OpenMP or multithread applications, make sure you have > >> > set affinity properly (GOMP_CPU_AFFINITY whith gnu, KMP_AFFINITY with > >> > intel). > >> > 8. make sure you have enough memory (--mem) unless performance may be > >> > degraded (swap). > >> > >> > The rule of thumb 4 may NOT be respected but if so, you need to be > >> > aware WHY you want to do that (for KNL, it may [or not] make sense > >> > [depending on cache modes]). > >> > >> > Remember than any multi-threaded (OpenMP or not) application may be > >> > victim of false sharing > >> > (https://en.wikipedia.org/wiki/False_sharing): in this case, profile > >> > (using cache metrics) may help to understand if this is the problem, > >> > and track it if so (you may use perf-record for that). > >> > >> > Understanding HW is not an easy thing: you really need to go step > >> > by step unless you have no chance to understand anything in the end. > >> > >> > Hope this may help !... > >> > >> > Franck > >> > >> > Note: activating/deactivating hyper-threading (if available - > >> > generally in BIOS when possible) may also change performances. > >> > >> > ----- Mail original ----- > >> >> De: "Barry Smith" > >> >> ?: "Damian Kaliszan" > >> >> Cc: "PETSc" > >> >> Envoy?: Mardi 4 Juillet 2017 19:04:36 > >> >> Objet: Re: [petsc-users] Is OpenMP still available for PETSc? > >> >> > >> >> > >> >> You may need to ask a slurm expert. I have no idea what > >> >> cpus-per-task > >> >> means > >> >> > >> >> > >> >> > On Jul 4, 2017, at 4:16 AM, Damian Kaliszan > >> >> > wrote: > >> >> > > >> >> > Hi, > >> >> > > >> >> > Yes, this is exactly what I meant. > >> >> > Please find attached output for 2 input datasets and for 2 various > >> >> > slurm > >> >> > configs each: > >> >> > > >> >> > A/ Matrix size=8000000x8000000 > >> >> > > >> >> > 1/ slurm-14432809.out, 930 ksp steps, ~90 secs > >> >> > > >> >> > > >> >> > #SBATCH --nodes=2 > >> >> > #SBATCH --ntasks=32 > >> >> > #SBATCH --ntasks-per-node=16 > >> >> > #SBATCH --cpus-per-task=4 > >> >> > > >> >> > 2/ slurm-14432810.out , 100.000 ksp steps, ~9700 secs > >> >> > > >> >> > #SBATCH --nodes=2 > >> >> > #SBATCH --ntasks=32 > >> >> > #SBATCH --ntasks-per-node=16 > >> >> > #SBATCH --cpus-per-task=2 > >> >> > > >> >> > > >> >> > > >> >> > B/ Matrix size=1000x1000 > >> >> > > >> >> > 1/ slurm-23716.out, 511 ksp steps, ~ 28 secs > >> >> > #SBATCH --nodes=1 > >> >> > #SBATCH --ntasks=64 > >> >> > #SBATCH --ntasks-per-node=64 > >> >> > #SBATCH --cpus-per-task=4 > >> >> > > >> >> > > >> >> > 2/ slurm-23718.out, 94 ksp steps, ~ 4 secs > >> >> > > >> >> > #SBATCH --nodes=1 > >> >> > #SBATCH --ntasks=4 > >> >> > #SBATCH --ntasks-per-node=4 > >> >> > #SBATCH --cpus-per-task=4 > >> >> > > >> >> > > >> >> > I would really appreciate any help...:) > >> >> > > >> >> > Best, > >> >> > Damian > >> >> > > >> >> > > >> >> > > >> >> > W li?cie datowanym 3 lipca 2017 (16:29:15) napisano: > >> >> > > >> >> > > >> >> > On Mon, Jul 3, 2017 at 9:23 AM, Damian Kaliszan > >> >> > > >> >> > wrote: > >> >> > Hi, > >> >> > > >> >> > > >> >> > >> 1) You can call Bcast on PETSC_COMM_WORLD > >> >> > > >> >> > To be honest I can't find Bcast method in petsc4py.PETSc.Comm > >> >> > (I'm > >> >> > using petsc4py) > >> >> > > >> >> > >> 2) If you are using WORLD, the number of iterates will be the same > >> >> > >> on > >> >> > >> each process since iteration is collective. > >> >> > > >> >> > Yes, this is how it should be. But what I noticed is that > >> >> > for > >> >> > different --cpus-per-task numbers in slurm script I get > >> >> > different > >> >> > number of solver iterations which is in turn related to timings. > >> >> > The > >> >> > imparity is huge. For example for some configurations > >> >> > where > >> >> > --cpus-per-task=1 I receive 900 > >> >> > iterations and for --cpus-per-task=2 I receive valid number of > >> >> > 100.000 > >> >> > which is set as max > >> >> > iter number set when setting solver tolerances. > >> >> > > >> >> > I am trying to understand what you are saying. You mean that you make > >> >> > 2 > >> >> > different runs and get a different > >> >> > number of iterates with a KSP? In order to answer questions about > >> >> > convergence, we need to see the output > >> >> > of > >> >> > > >> >> > -ksp_view -ksp_monitor_true_residual -ksp_converged_reason > >> >> > > >> >> > for all cases. > >> >> > > >> >> > Thanks, > >> >> > > >> >> > Matt > >> >> > > >> >> > Best, > >> >> > Damian > >> >> > > >> >> > > >> >> > > >> >> > > >> >> > -- > >> >> > What most experimenters take for granted before they begin their > >> >> > experiments is infinitely more interesting than any results to which > >> >> > their > >> >> > experiments lead. > >> >> > -- Norbert Wiener > >> >> > > >> >> > http://www.caam.rice.edu/~mk51/ > >> >> > > >> >> > > >> >> > > >> >> > > >> >> > > >> >> > ------------------------------------------------------- > >> >> > Damian Kaliszan > >> >> > > >> >> > Poznan Supercomputing and Networking Center > >> >> > HPC and Data Centres Technologies > >> >> > ul. Jana Paw?a II 10 > >> >> > 61-139 Poznan > >> >> > POLAND > >> >> > > >> >> > phone (+48 61) 858 5109 > >> >> > e-mail damian at man.poznan.pl > >> >> > www - http://www.man.poznan.pl/ > >> >> > ------------------------------------------------------- > >> >> > > >> >> > >> >> > > > From aotero at fi.uba.ar Thu Jul 6 09:10:40 2017 From: aotero at fi.uba.ar (Alejandro D Otero) Date: Thu, 6 Jul 2017 11:10:40 -0300 Subject: [petsc-users] TS for explicit equations Message-ID: Hello, I'trying to solve an ODE system using PETSc TS through its wrapper petsc4py, and I'm having problems with the setting. The problem is of the kind: u_t = G(t, u) with u being a vector with DoF from a FEM problem and G is computed by a series of matrix operations and manipulations, which are implemented for distributed domains. I set up the problem as explicit using the TSSetRHSFunction, but when I try to solve it using explicit solvers I got a weird behavior: the unknown variable (u above) is never updated (I checked it inside the RHS function I provided), despite having a non null evaluation of f = G(t, u). This happens for RK, SSP, SUNDIALS (adams), but strangely not for FE (where u is updated in every step). That is what disturbs me, because I'd like to use the more sophisticated solvers. I followed this steps in order to get the time evolution of u: # Create and Setup time stepper ts = PETSc.TS().create(comm=self.comm) # Set problem type ts.setProblemType(ts.ProblemType.NONLINEAR) # Set solver type ts.setType(ts.Type.RK) # Set initial time ts.setTime(sTime) # Set max time or max number of iterations ts.setDuration(eTime, max_steps=maxSteps) # Set how to treat the final step ts.setExactFinalTime(ts.ExactFinalTime.INTERPOLATE) # Allocate variables for internal computations of the RHS vector 'U' for the solution vector 'f' for the RHS evaluation # Set rhs function ts.setRHSFunction(self.evalRHSFunction, self.g) (where evalRHSFunction has the form f(self, ts, t, Vort, f)) # Set fuction to be run after each step ts.setPostStep(convergedStepFunction) # Set from other command line options ts.setFromOptions() # Set initial conditions in vector 'U' # Run TS ts.solve(U) Is there anything am I doing wrong? Thanks in advance, Alejandro -------------- next part -------------- An HTML attachment was scrubbed... URL: From errabiisohaib at gmail.com Thu Jul 6 10:48:58 2017 From: errabiisohaib at gmail.com (errabii sohaib) Date: Thu, 6 Jul 2017 17:48:58 +0200 Subject: [petsc-users] Slepc reading distributed matrix from files In-Reply-To: References: Message-ID: Hi everyone, I am trying to use Mat.view and Mat.load that you suggested. Regardless of the fact that the matrix i get is not what i had initially, my question is about how Mat.load reads the matrix in Parallel. Am i able to read the matrix in parallel regardless how it was written with Mat.view() ? My second question is about the difference between PETSc.COMM_WORLD and MPI.COMM_WORLD, i have read in the user's manual that they are the practically the same, but creating a viewer with MPI.COMM_WORLD returns an error and it works with PETSc.COMM_WORLD. ps: *Here is the code i am using to write the matrix* comm = PETSc.COMM_WORLD rank = comm.Get_rank() size = comm.Get_size() sizeGlob,nnzGlob,size,nnz,I,J,A=readMat('jacobian/matJ%i'%rank) M=PETSc.Mat() M.create() M.setSizes(size=(sizeGlob,sizeGlob)) M.setType('aij') M.setUp() for i in range(nnz): #each proc holds different I,J,A and i simply fill in the matrix M[I[i]-1,J[i]-1]=A[i] M.assemblyBegin() M.assemblyEnd() vi = PETSc.Viewer() vi.createBinary('matJacobian',mode=1,comm=comm) M.view(viewer=vi) *And the code i am using to read it:* comm = PETSc.COMM_WORLD rank = comm.Get_rank() size = comm.Get_size() A = PETSc.Mat(comm) vi = PETSc.Viewer() vi.createBinary('matJacobian',mode=0,comm=comm) A.load(vi) Checking the matrix after reading it with A.getType returns seqaij as if it wasn't distributed on each proc! Thank you so much for your time, Sohaib -------------- next part -------------- An HTML attachment was scrubbed... URL: From robert.annewandter at opengosim.com Thu Jul 6 14:03:04 2017 From: robert.annewandter at opengosim.com (Robert Annewandter) Date: Thu, 6 Jul 2017 20:03:04 +0100 Subject: [petsc-users] CPR-AMG: SNES with two cores worse than with one Message-ID: <293da4be-1eaa-9ac0-54fe-171832a5b4af@opengosim.com> Hi all, I like to understand why the SNES of my CPR-AMG Two-Stage Preconditioner (with KSPFGMRES + multipl. PCComposite (PCGalerkin with KSPGMRES + BoomerAMG, PCBJacobi + PCLU init) on a 24,000 x 24,000 matrix) struggles to converge when using two cores instead of one. Because of the adaptive time stepping of the Newton, this leads to severe cuts in time step. This is how I run it with two cores mpirun \ -n 2 pflotran \ -pflotranin het.pflinput \ -ksp_monitor_true_residual \ -flow_snes_view \ -flow_snes_converged_reason \ -flow_sub_1_pc_type bjacobi \ -flow_sub_1_sub_pc_type lu \ -flow_sub_1_sub_pc_factor_pivot_in_blocks true\ -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ -options_left \ -log_summary \ -info With one core I get (after grepping the crap away from -info): Step 32 Time= 1.80000E+01 [...] 0 2r: 1.58E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 7.18E-03 iu: 0.00E+00 rsn: 0 [0] SNESComputeJacobian(): Rebuilding preconditioner Residual norms for flow_ solve. 0 KSP unpreconditioned resid norm 1.581814306485e-02 true resid norm 1.581814306485e-02 ||r(i)||/||b|| 1.000000000000e+00 Residual norms for flow_sub_0_galerkin_ solve. 0 KSP preconditioned resid norm 5.697603110484e+07 true resid norm 5.175721849125e+03 ||r(i)||/||b|| 5.037527476892e+03 1 KSP preconditioned resid norm 5.041509073319e+06 true resid norm 3.251596928176e+02 ||r(i)||/||b|| 3.164777657484e+02 2 KSP preconditioned resid norm 1.043761838360e+06 true resid norm 8.957519558348e+01 ||r(i)||/||b|| 8.718349288342e+01 3 KSP preconditioned resid norm 1.129189815646e+05 true resid norm 2.722436912053e+00 ||r(i)||/||b|| 2.649746479496e+00 4 KSP preconditioned resid norm 8.829637298082e+04 true resid norm 8.026373593492e+00 ||r(i)||/||b|| 7.812065388300e+00 5 KSP preconditioned resid norm 6.506021637694e+04 true resid norm 3.479889319880e+00 ||r(i)||/||b|| 3.386974527698e+00 6 KSP preconditioned resid norm 6.392263200180e+04 true resid norm 3.819202631980e+00 ||r(i)||/||b|| 3.717228003987e+00 7 KSP preconditioned resid norm 2.464946645480e+04 true resid norm 7.329964753388e-01 ||r(i)||/||b|| 7.134251013911e-01 8 KSP preconditioned resid norm 2.603879153772e+03 true resid norm 2.035525412004e-02 ||r(i)||/||b|| 1.981175861414e-02 9 KSP preconditioned resid norm 1.774410462754e+02 true resid norm 3.001214973121e-03 ||r(i)||/||b|| 2.921081026352e-03 10 KSP preconditioned resid norm 1.664227038378e+01 true resid norm 3.413136309181e-04 ||r(i)||/||b|| 3.322003855903e-04 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 1.131868956745e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 2.067297386780e+07 at iteration 11 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=1 [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 3.590873180642e-01 near zero implies inconsistent rhs [0] SNESSolve_NEWTONLS(): fnorm=1.5818143064846742e-02, gnorm=1.0695649833687331e-02, ynorm=4.6826522561266171e+02, lssucceed=0 [0] SNESConvergedDefault(): Converged due to small update length: 4.682652256127e+02 < 1.000000000000e-05 * 3.702480426117e+09 1 2r: 1.07E-02 2x: 3.70E+09 2u: 4.68E+02 ir: 5.05E-03 iu: 4.77E+01 rsn: stol Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 But with two cores I get: Step 32 Time= 1.80000E+01 [...] 0 2r: 6.16E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 3.63E-03 iu: 0.00E+00 rsn: 0 [0] SNESComputeJacobian(): Rebuilding preconditioner Residual norms for flow_ solve. 0 KSP unpreconditioned resid norm 6.162760088924e-03 true resid norm 6.162760088924e-03 ||r(i)||/||b|| 1.000000000000e+00 Residual norms for flow_sub_0_galerkin_ solve. 0 KSP preconditioned resid norm 8.994949630499e+08 true resid norm 7.982144380936e-01 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 8.950556502615e+08 true resid norm 1.550138696155e+00 ||r(i)||/||b|| 1.942007839218e+00 2 KSP preconditioned resid norm 1.044849684205e+08 true resid norm 2.166193480531e+00 ||r(i)||/||b|| 2.713798920631e+00 3 KSP preconditioned resid norm 8.209708619718e+06 true resid norm 3.076045005154e-01 ||r(i)||/||b|| 3.853657436340e-01 4 KSP preconditioned resid norm 3.027461352422e+05 true resid norm 1.207731865714e-02 ||r(i)||/||b|| 1.513041869549e-02 5 KSP preconditioned resid norm 1.595302164817e+04 true resid norm 4.123713694368e-04 ||r(i)||/||b|| 5.166172769585e-04 6 KSP preconditioned resid norm 1.898935810797e+03 true resid norm 8.275885058330e-05 ||r(i)||/||b|| 1.036799719897e-04 7 KSP preconditioned resid norm 1.429881682558e+02 true resid norm 4.751240525466e-06 ||r(i)||/||b|| 5.952335987324e-06 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 8.404003313455e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.994949630499e+08 at iteration 8 8 KSP preconditioned resid norm 8.404003313455e+00 true resid norm 3.841921844578e-07 ||r(i)||/||b|| 4.813145016211e-07 1 KSP unpreconditioned resid norm 6.162162548202e-03 true resid norm 6.162162548202e-03 ||r(i)||/||b|| 9.999030400804e-01 Residual norms for flow_sub_0_galerkin_ solve. 0 KSP preconditioned resid norm 4.360556381209e+07 true resid norm 1.000000245433e+00 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 5.385519331932e+06 true resid norm 8.785183939860e-02 ||r(i)||/||b|| 8.785181783689e-02 2 KSP preconditioned resid norm 4.728931283459e+05 true resid norm 2.008708805316e-02 ||r(i)||/||b|| 2.008708312313e-02 3 KSP preconditioned resid norm 2.734215698319e+04 true resid norm 6.418720397673e-03 ||r(i)||/||b|| 6.418718822309e-03 4 KSP preconditioned resid norm 1.002270029334e+04 true resid norm 4.040289515991e-03 ||r(i)||/||b|| 4.040288524372e-03 5 KSP preconditioned resid norm 1.321280190971e+03 true resid norm 1.023292238313e-04 ||r(i)||/||b|| 1.023291987163e-04 6 KSP preconditioned resid norm 6.594292964815e+01 true resid norm 1.877106733170e-06 ||r(i)||/||b|| 1.877106272467e-06 7 KSP preconditioned resid norm 7.816325147216e+00 true resid norm 2.552611664980e-07 ||r(i)||/||b|| 2.552611038486e-07 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.391568446109e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.360556381209e+07 at iteration 8 8 KSP preconditioned resid norm 6.391568446109e-01 true resid norm 1.680724939670e-08 ||r(i)||/||b|| 1.680724527166e-08 2 KSP unpreconditioned resid norm 4.328902922753e-07 true resid norm 4.328902922752e-07 ||r(i)||/||b|| 7.024292460341e-05 Residual norms for flow_sub_0_galerkin_ solve. 0 KSP preconditioned resid norm 8.794597825780e+08 true resid norm 1.000000094566e+00 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 8.609906572102e+08 true resid norm 2.965044981249e+00 ||r(i)||/||b|| 2.965044700856e+00 2 KSP preconditioned resid norm 9.318108989314e+07 true resid norm 1.881262939380e+00 ||r(i)||/||b|| 1.881262761477e+00 3 KSP preconditioned resid norm 6.908723262483e+06 true resid norm 2.639592490398e-01 ||r(i)||/||b|| 2.639592240782e-01 4 KSP preconditioned resid norm 2.651677791227e+05 true resid norm 9.736480169584e-03 ||r(i)||/||b|| 9.736479248845e-03 5 KSP preconditioned resid norm 1.192178471172e+04 true resid norm 3.082839752692e-04 ||r(i)||/||b|| 3.082839461160e-04 6 KSP preconditioned resid norm 1.492201446262e+03 true resid norm 4.633866284506e-05 ||r(i)||/||b|| 4.633865846301e-05 7 KSP preconditioned resid norm 1.160670017241e+02 true resid norm 2.821157348522e-06 ||r(i)||/||b|| 2.821157081737e-06 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.447568262216e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.794597825780e+08 at iteration 8 8 KSP preconditioned resid norm 6.447568262216e+00 true resid norm 1.516068561348e-07 ||r(i)||/||b|| 1.516068417980e-07 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.135731709822e-15 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.162760088924e-03 at iteration 3 3 KSP unpreconditioned resid norm 6.135731709822e-15 true resid norm 1.142020328809e-14 ||r(i)||/||b|| 1.853098793933e-12 [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=3 [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 1.998388224666e-02 near zero implies inconsistent rhs [0] SNESSolve_NEWTONLS(): fnorm=6.1627600889243711e-03, gnorm=1.0406503258190572e-02, ynorm=6.2999025681245366e+04, lssucceed=0 1 2r: 1.04E-02 2x: 3.70E+09 2u: 6.30E+04 ir: 6.54E-03 iu: 5.00E+04 rsn: 0 [0] SNESComputeJacobian(): Rebuilding preconditioner Residual norms for flow_ solve. 0 KSP unpreconditioned resid norm 1.040650325819e-02 true resid norm 1.040650325819e-02 ||r(i)||/||b|| 1.000000000000e+00 Residual norms for flow_sub_0_galerkin_ solve. 0 KSP preconditioned resid norm 6.758906811264e+07 true resid norm 9.814998431686e-01 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.503922806424e+06 true resid norm 2.275130113021e-01 ||r(i)||/||b|| 2.318013730574e-01 2 KSP preconditioned resid norm 3.316753614870e+05 true resid norm 3.820733530238e-02 ||r(i)||/||b|| 3.892750016040e-02 3 KSP preconditioned resid norm 2.956751700483e+04 true resid norm 2.143772538677e-03 ||r(i)||/||b|| 2.184180215207e-03 4 KSP preconditioned resid norm 1.277067042524e+03 true resid norm 9.093614251311e-05 ||r(i)||/||b|| 9.265018547485e-05 5 KSP preconditioned resid norm 1.060996002446e+02 true resid norm 1.042893700050e-05 ||r(i)||/||b|| 1.062551061326e-05 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 5.058127343285e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.758906811264e+07 at iteration 6 6 KSP preconditioned resid norm 5.058127343285e+00 true resid norm 4.054770602120e-07 ||r(i)||/||b|| 4.131198420807e-07 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.449606189225e-10 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.040650325819e-02 at iteration 1 1 KSP unpreconditioned resid norm 4.449606189225e-10 true resid norm 4.449606189353e-10 ||r(i)||/||b|| 4.275793779098e-08 [0] SNESSolve_NEWTONLS(): iter=1, linear solve iterations=1 [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.300066663571e-02 near zero implies inconsistent rhs [0] SNESSolve_NEWTONLS(): fnorm=1.0406503258190572e-02, gnorm=7.3566280848133728e-02, ynorm=7.9500485128639993e+04, lssucceed=0 2 2r: 7.36E-02 2x: 3.70E+09 2u: 7.95E+04 ir: 4.62E-02 iu: 5.00E+04 rsn: 0 [0] SNESComputeJacobian(): Rebuilding preconditioner Residual norms for flow_ solve. 0 KSP unpreconditioned resid norm 7.356628084813e-02 true resid norm 7.356628084813e-02 ||r(i)||/||b|| 1.000000000000e+00 Residual norms for flow_sub_0_galerkin_ solve. 0 KSP preconditioned resid norm 7.253424029194e+06 true resid norm 9.647008645250e-01 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 7.126940190688e+06 true resid norm 1.228009197928e+00 ||r(i)||/||b|| 1.272942984800e+00 2 KSP preconditioned resid norm 9.391591432635e+05 true resid norm 7.804929162756e-01 ||r(i)||/||b|| 8.090517433711e-01 3 KSP preconditioned resid norm 6.538499674761e+04 true resid norm 5.503467432893e-02 ||r(i)||/||b|| 5.704843475602e-02 4 KSP preconditioned resid norm 1.593713396575e+04 true resid norm 8.902701363763e-02 ||r(i)||/||b|| 9.228457951208e-02 5 KSP preconditioned resid norm 4.837260621464e+02 true resid norm 2.966772992825e-03 ||r(i)||/||b|| 3.075329464213e-03 6 KSP preconditioned resid norm 1.681372767335e+02 true resid norm 5.312467443025e-04 ||r(i)||/||b|| 5.506854651406e-04 7 KSP preconditioned resid norm 1.271478850717e+01 true resid norm 2.123810020488e-05 ||r(i)||/||b|| 2.201521838103e-05 8 KSP preconditioned resid norm 1.262723712696e+00 true resid norm 1.150572715331e-06 ||r(i)||/||b|| 1.192673042641e-06 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 9.053072585125e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.253424029194e+06 at iteration 9 9 KSP preconditioned resid norm 9.053072585125e-02 true resid norm 9.475050575058e-08 ||r(i)||/||b|| 9.821749853747e-08 1 KSP unpreconditioned resid norm 8.171589173162e-03 true resid norm 8.171589173162e-03 ||r(i)||/||b|| 1.110779161180e-01 Residual norms for flow_sub_0_galerkin_ solve. 0 KSP preconditioned resid norm 4.345765068989e+07 true resid norm 9.999992231691e-01 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 5.388715093466e+06 true resid norm 8.125387327699e-02 ||r(i)||/||b|| 8.125393639755e-02 2 KSP preconditioned resid norm 4.763725726436e+05 true resid norm 2.464285618036e-02 ||r(i)||/||b|| 2.464287532371e-02 3 KSP preconditioned resid norm 2.287746683380e+04 true resid norm 7.224823080100e-03 ||r(i)||/||b|| 7.224828692570e-03 4 KSP preconditioned resid norm 4.872858764091e+03 true resid norm 3.972261388893e-03 ||r(i)||/||b|| 3.972264474670e-03 5 KSP preconditioned resid norm 8.670449895323e+02 true resid norm 2.359005963873e-04 ||r(i)||/||b|| 2.359007796423e-04 6 KSP preconditioned resid norm 4.252589693890e+01 true resid norm 1.471904261226e-06 ||r(i)||/||b|| 1.471905404648e-06 7 KSP preconditioned resid norm 5.128476471782e+00 true resid norm 1.643725157865e-07 ||r(i)||/||b|| 1.643726434763e-07 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.311901915856e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.345765068989e+07 at iteration 8 8 KSP preconditioned resid norm 4.311901915856e-01 true resid norm 1.166123921637e-08 ||r(i)||/||b|| 1.166124827519e-08 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.373662391739e-09 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.356628084813e-02 at iteration 2 2 KSP unpreconditioned resid norm 2.373662391739e-09 true resid norm 2.373662391658e-09 ||r(i)||/||b|| 3.226562990941e-08 [0] SNESSolve_NEWTONLS(): iter=2, linear solve iterations=2 [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.343326231305e-02 near zero implies inconsistent rhs [0] SNESSolve_NEWTONLS(): fnorm=7.3566280848133728e-02, gnorm=7.2259942496422647e-02, ynorm=6.3156901950486099e+04, lssucceed=0 3 2r: 7.23E-02 2x: 3.70E+09 2u: 6.32E+04 ir: 4.52E-02 iu: 5.00E+04 rsn: 0 [0] SNESComputeJacobian(): Rebuilding preconditioner Residual norms for flow_ solve. 0 KSP unpreconditioned resid norm 7.225994249642e-02 true resid norm 7.225994249642e-02 ||r(i)||/||b|| 1.000000000000e+00 Residual norms for flow_sub_0_galerkin_ solve. 0 KSP preconditioned resid norm 7.705582590638e+05 true resid norm 9.649751442741e-01 ||r(i)||/||b|| 1.000000000000e+00 1 KSP preconditioned resid norm 2.444424220392e+04 true resid norm 8.243110200738e-03 ||r(i)||/||b|| 8.542303135630e-03 2 KSP preconditioned resid norm 2.080899648412e+03 true resid norm 7.642343147053e-04 ||r(i)||/||b|| 7.919730567570e-04 3 KSP preconditioned resid norm 9.911171129874e+02 true resid norm 5.904182179180e-05 ||r(i)||/||b|| 6.118481096859e-05 4 KSP preconditioned resid norm 5.258230282482e+02 true resid norm 2.043366677644e-04 ||r(i)||/||b|| 2.117532964210e-04 5 KSP preconditioned resid norm 5.522830460456e+01 true resid norm 1.710780366056e-05 ||r(i)||/||b|| 1.772875059225e-05 6 KSP preconditioned resid norm 5.922280741715e+00 true resid norm 1.543198740828e-06 ||r(i)||/||b|| 1.599210870855e-06 7 KSP preconditioned resid norm 3.339500859115e-01 true resid norm 1.221335666427e-07 ||r(i)||/||b|| 1.265665414984e-07 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 3.329208597672e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.705582590638e+05 at iteration 8 8 KSP preconditioned resid norm 3.329208597672e-02 true resid norm 9.758240835324e-09 ||r(i)||/||b|| 1.011242713683e-08 [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.697128456432e-11 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.225994249642e-02 at iteration 1 1 KSP unpreconditioned resid norm 2.697128456432e-11 true resid norm 2.697128457142e-11 ||r(i)||/||b|| 3.732536124389e-10 [0] SNESSolve_NEWTONLS(): iter=3, linear solve iterations=1 [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX||4.329227684222e-02 near zero implies inconsistent rhs [0] SNESSolve_NEWTONLS(): fnorm=7.2259942496422647e-02, gnorm=5.4435602192925014e-01, ynorm=2.7049750229137400e+04, lssucceed=0 [0] SNESConvergedDefault(): Converged due to small update length: 2.704975022914e+04 < 1.000000000000e-05 * 3.702469482296e+09 4 2r: 5.44E-01 2x: 3.70E+09 2u: 2.70E+04 ir: 3.84E-01 iu: 2.34E+04 rsn: stol Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 4 As the simulation advances this behaviour leads to frequent time step cuts because of 8 subsequently failed Newton iterations, which brings the simulation practically to a halt. Is the Block Jacobi not a good choice? Better ASM with huge overlap? Or is there something wrong with my RHS? Maybe the SNES, SNESLS, KSP tolerances need better tuning? Grateful for any clarifying words! Robert My SNES_view is: SNES Object: (flow_) 2 MPI processes type: newtonls maximum iterations=8, maximum function evaluations=10000 tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 total number of linear solver iterations=1 total number of function evaluations=2 norm schedule ALWAYS SNESLineSearch Object: (flow_) 2 MPI processes type: basic maxstep=1.000000e+08, minlambda=1.000000e-05 tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 maximum iterations=40 using user-defined precheck step KSP Object: (flow_) 2 MPI processes type: fgmres GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement GMRES: happy breakdown tolerance 1e-30 maximum iterations=200, initial guess is zero tolerances: relative=1e-07, absolute=1e-50, divergence=10000. right preconditioning using UNPRECONDITIONED norm type for convergence test PC Object: (flow_) 2 MPI processes type: composite Composite PC type - MULTIPLICATIVE PCs on composite preconditioner follow --------------------------------- PC Object: (flow_sub_0_) 2 MPI processes type: galerkin Galerkin PC KSP on Galerkin follow --------------------------------- KSP Object: (flow_sub_0_galerkin_) 2 MPI processes type: gmres GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement GMRES: happy breakdown tolerance 1e-30 maximum iterations=200, initial guess is zero tolerances: relative=1e-07, absolute=1e-50, divergence=10000. left preconditioning using PRECONDITIONED norm type for convergence test PC Object: (flow_sub_0_galerkin_) 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=8000, cols=8000 total: nonzeros=53600, allocated nonzeros=53600 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines linear system matrix = precond matrix: Mat Object: (flow_) 2 MPI processes type: mpibaij rows=24000, cols=24000, bs=3 total: nonzeros=482400, allocated nonzeros=482400 total number of mallocs used during MatSetValues calls =0 PC Object: (flow_sub_1_) 2 MPI processes type: bjacobi block Jacobi: number of blocks = 2 Local solve is same for all blocks, in the following KSP and PC objects: KSP Object: (flow_sub_1_sub_) 1 MPI processes type: preonly maximum iterations=10000, initial guess is zero tolerances: relative=1e-05, absolute=1e-50, divergence=10000. <------ not working: -flow_sub_1_sub_ksp_rtol 1e-7 left preconditioning using NONE norm type for convergence test PC Object: (flow_sub_1_sub_) 1 MPI processes type: lu out-of-place factorization tolerance for zero pivot 2.22045e-14 matrix ordering: nd factor fill ratio given 5., needed 18.3108 Factored matrix follows: Mat Object: 1 MPI processes type: seqbaij rows=12000, cols=12000, bs=3 package used to perform factorization: petsc total: nonzeros=4350654, allocated nonzeros=4350654 total number of mallocs used during MatSetValues calls =0 block size is 3 linear system matrix = precond matrix: Mat Object: (flow_) 1 MPI processes type: seqbaij rows=12000, cols=12000, bs=3 total: nonzeros=237600, allocated nonzeros=237600 total number of mallocs used during MatSetValues calls =0 block size is 3 linear system matrix = precond matrix: Mat Object: (flow_) 2 MPI processes type: mpibaij rows=24000, cols=24000, bs=3 total: nonzeros=482400, allocated nonzeros=482400 total number of mallocs used during MatSetValues calls =0 --------------------------------- linear system matrix = precond matrix: Mat Object: (flow_) 2 MPI processes type: mpibaij rows=24000, cols=24000, bs=3 total: nonzeros=482400, allocated nonzeros=482400 total number of mallocs used during MatSetValues calls =0 -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Thu Jul 6 15:02:30 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Thu, 6 Jul 2017 15:02:30 -0500 Subject: [petsc-users] Slepc reading distributed matrix from files In-Reply-To: References: Message-ID: <3456D270-B785-4FD6-81C1-1DA2C7050019@mcs.anl.gov> > On Jul 6, 2017, at 10:48 AM, errabii sohaib wrote: > > Hi everyone, > > I am trying to use Mat.view and Mat.load that you suggested. Regardless of the fact that the matrix i get is not what i had initially, my question is about how Mat.load reads the matrix in Parallel. Am i able to read the matrix in parallel regardless how it was written with Mat.view() ? Yes, you can save on one process and read it in parallel. > My second question is about the difference between PETSc.COMM_WORLD and MPI.COMM_WORLD, i have read in the user's manual that they are the practically the same, but creating a viewer with MPI.COMM_WORLD returns an error and it works with PETSc.COMM_WORLD. This may be a petsc4py thing, just use PETSc.COMM_WORLD. > > ps: > Here is the code i am using to write the matrix > > comm = PETSc.COMM_WORLD > rank = comm.Get_rank() > size = comm.Get_size() > > sizeGlob,nnzGlob,size,nnz,I,J,A=readMat('jacobian/matJ%i'%rank) > > M=PETSc.Mat() > M.create() > M.setSizes(size=(sizeGlob,sizeGlob)) > M.setType('aij') > M.setUp() > for i in range(nnz): #each proc holds different I,J,A and i simply fill in the matrix > M[I[i]-1,J[i]-1]=A[i] > M.assemblyBegin() > M.assemblyEnd() > > vi = PETSc.Viewer() > vi.createBinary('matJacobian',mode=1,comm=comm) > M.view(viewer=vi) > > And the code i am using to read it: > > comm = PETSc.COMM_WORLD > rank = comm.Get_rank() > size = comm.Get_size() > > A = PETSc.Mat(comm) > vi = PETSc.Viewer() > vi.createBinary('matJacobian',mode=0,comm=comm) > A.load(vi) > > Checking the matrix after reading it with A.getType returns seqaij as if it wasn't distributed on each proc! This works fine in C, again could be a petsc4py thing. I don't know why it wouldn't work. Can you run with -info to get more information about what PETSc is doing? > > Thank you so much for your time, > Sohaib > From bsmith at mcs.anl.gov Thu Jul 6 15:24:03 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Thu, 6 Jul 2017 15:24:03 -0500 Subject: [petsc-users] CPR-AMG: SNES with two cores worse than with one In-Reply-To: <293da4be-1eaa-9ac0-54fe-171832a5b4af@opengosim.com> References: <293da4be-1eaa-9ac0-54fe-171832a5b4af@opengosim.com> Message-ID: So on one process the outer linear solver takes a single iteration this is because the block Jacobi with LU and one block is a direct solver. > 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 > 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 On two processes the outer linear solver takes a few iterations to solver, this is to be expected. But what you sent doesn't give any indication about SNES not converging. Please turn off all inner linear solver monitoring and just run with -ksp_monitor_true_residual -snes_monitor -snes_lineseach_monitor -snes_converged_reason Barry > On Jul 6, 2017, at 2:03 PM, Robert Annewandter wrote: > > Hi all, > > I like to understand why the SNES of my CPR-AMG Two-Stage Preconditioner (with KSPFGMRES + multipl. PCComposite (PCGalerkin with KSPGMRES + BoomerAMG, PCBJacobi + PCLU init) on a 24,000 x 24,000 matrix) struggles to converge when using two cores instead of one. Because of the adaptive time stepping of the Newton, this leads to severe cuts in time step. > > This is how I run it with two cores > > mpirun \ > -n 2 pflotran \ > -pflotranin het.pflinput \ > -ksp_monitor_true_residual \ > -flow_snes_view \ > -flow_snes_converged_reason \ > -flow_sub_1_pc_type bjacobi \ > -flow_sub_1_sub_pc_type lu \ > -flow_sub_1_sub_pc_factor_pivot_in_blocks true\ > -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ > -options_left \ > -log_summary \ > -info > > > With one core I get (after grepping the crap away from -info): > > Step 32 Time= 1.80000E+01 > > [...] > > 0 2r: 1.58E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 7.18E-03 iu: 0.00E+00 rsn: 0 > [0] SNESComputeJacobian(): Rebuilding preconditioner > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 1.581814306485e-02 true resid norm 1.581814306485e-02 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 5.697603110484e+07 true resid norm 5.175721849125e+03 ||r(i)||/||b|| 5.037527476892e+03 > 1 KSP preconditioned resid norm 5.041509073319e+06 true resid norm 3.251596928176e+02 ||r(i)||/||b|| 3.164777657484e+02 > 2 KSP preconditioned resid norm 1.043761838360e+06 true resid norm 8.957519558348e+01 ||r(i)||/||b|| 8.718349288342e+01 > 3 KSP preconditioned resid norm 1.129189815646e+05 true resid norm 2.722436912053e+00 ||r(i)||/||b|| 2.649746479496e+00 > 4 KSP preconditioned resid norm 8.829637298082e+04 true resid norm 8.026373593492e+00 ||r(i)||/||b|| 7.812065388300e+00 > 5 KSP preconditioned resid norm 6.506021637694e+04 true resid norm 3.479889319880e+00 ||r(i)||/||b|| 3.386974527698e+00 > 6 KSP preconditioned resid norm 6.392263200180e+04 true resid norm 3.819202631980e+00 ||r(i)||/||b|| 3.717228003987e+00 > 7 KSP preconditioned resid norm 2.464946645480e+04 true resid norm 7.329964753388e-01 ||r(i)||/||b|| 7.134251013911e-01 > 8 KSP preconditioned resid norm 2.603879153772e+03 true resid norm 2.035525412004e-02 ||r(i)||/||b|| 1.981175861414e-02 > 9 KSP preconditioned resid norm 1.774410462754e+02 true resid norm 3.001214973121e-03 ||r(i)||/||b|| 2.921081026352e-03 > 10 KSP preconditioned resid norm 1.664227038378e+01 true resid norm 3.413136309181e-04 ||r(i)||/||b|| 3.322003855903e-04 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 1.131868956745e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 2.067297386780e+07 at iteration 11 > 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 > 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 > [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=1 > [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 3.590873180642e-01 near zero implies inconsistent rhs > [0] SNESSolve_NEWTONLS(): fnorm=1.5818143064846742e-02, gnorm=1.0695649833687331e-02, ynorm=4.6826522561266171e+02, lssucceed=0 > [0] SNESConvergedDefault(): Converged due to small update length: 4.682652256127e+02 < 1.000000000000e-05 * 3.702480426117e+09 > 1 2r: 1.07E-02 2x: 3.70E+09 2u: 4.68E+02 ir: 5.05E-03 iu: 4.77E+01 rsn: stol > Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 > > > > But with two cores I get: > > > Step 32 Time= 1.80000E+01 > > [...] > > 0 2r: 6.16E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 3.63E-03 iu: 0.00E+00 rsn: 0 > [0] SNESComputeJacobian(): Rebuilding preconditioner > > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 6.162760088924e-03 true resid norm 6.162760088924e-03 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 8.994949630499e+08 true resid norm 7.982144380936e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 8.950556502615e+08 true resid norm 1.550138696155e+00 ||r(i)||/||b|| 1.942007839218e+00 > 2 KSP preconditioned resid norm 1.044849684205e+08 true resid norm 2.166193480531e+00 ||r(i)||/||b|| 2.713798920631e+00 > 3 KSP preconditioned resid norm 8.209708619718e+06 true resid norm 3.076045005154e-01 ||r(i)||/||b|| 3.853657436340e-01 > 4 KSP preconditioned resid norm 3.027461352422e+05 true resid norm 1.207731865714e-02 ||r(i)||/||b|| 1.513041869549e-02 > 5 KSP preconditioned resid norm 1.595302164817e+04 true resid norm 4.123713694368e-04 ||r(i)||/||b|| 5.166172769585e-04 > 6 KSP preconditioned resid norm 1.898935810797e+03 true resid norm 8.275885058330e-05 ||r(i)||/||b|| 1.036799719897e-04 > 7 KSP preconditioned resid norm 1.429881682558e+02 true resid norm 4.751240525466e-06 ||r(i)||/||b|| 5.952335987324e-06 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 8.404003313455e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.994949630499e+08 at iteration 8 > 8 KSP preconditioned resid norm 8.404003313455e+00 true resid norm 3.841921844578e-07 ||r(i)||/||b|| 4.813145016211e-07 > 1 KSP unpreconditioned resid norm 6.162162548202e-03 true resid norm 6.162162548202e-03 ||r(i)||/||b|| 9.999030400804e-01 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 4.360556381209e+07 true resid norm 1.000000245433e+00 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.385519331932e+06 true resid norm 8.785183939860e-02 ||r(i)||/||b|| 8.785181783689e-02 > 2 KSP preconditioned resid norm 4.728931283459e+05 true resid norm 2.008708805316e-02 ||r(i)||/||b|| 2.008708312313e-02 > 3 KSP preconditioned resid norm 2.734215698319e+04 true resid norm 6.418720397673e-03 ||r(i)||/||b|| 6.418718822309e-03 > 4 KSP preconditioned resid norm 1.002270029334e+04 true resid norm 4.040289515991e-03 ||r(i)||/||b|| 4.040288524372e-03 > 5 KSP preconditioned resid norm 1.321280190971e+03 true resid norm 1.023292238313e-04 ||r(i)||/||b|| 1.023291987163e-04 > 6 KSP preconditioned resid norm 6.594292964815e+01 true resid norm 1.877106733170e-06 ||r(i)||/||b|| 1.877106272467e-06 > 7 KSP preconditioned resid norm 7.816325147216e+00 true resid norm 2.552611664980e-07 ||r(i)||/||b|| 2.552611038486e-07 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.391568446109e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.360556381209e+07 at iteration 8 > 8 KSP preconditioned resid norm 6.391568446109e-01 true resid norm 1.680724939670e-08 ||r(i)||/||b|| 1.680724527166e-08 > 2 KSP unpreconditioned resid norm 4.328902922753e-07 true resid norm 4.328902922752e-07 ||r(i)||/||b|| 7.024292460341e-05 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 8.794597825780e+08 true resid norm 1.000000094566e+00 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 8.609906572102e+08 true resid norm 2.965044981249e+00 ||r(i)||/||b|| 2.965044700856e+00 > 2 KSP preconditioned resid norm 9.318108989314e+07 true resid norm 1.881262939380e+00 ||r(i)||/||b|| 1.881262761477e+00 > 3 KSP preconditioned resid norm 6.908723262483e+06 true resid norm 2.639592490398e-01 ||r(i)||/||b|| 2.639592240782e-01 > 4 KSP preconditioned resid norm 2.651677791227e+05 true resid norm 9.736480169584e-03 ||r(i)||/||b|| 9.736479248845e-03 > 5 KSP preconditioned resid norm 1.192178471172e+04 true resid norm 3.082839752692e-04 ||r(i)||/||b|| 3.082839461160e-04 > 6 KSP preconditioned resid norm 1.492201446262e+03 true resid norm 4.633866284506e-05 ||r(i)||/||b|| 4.633865846301e-05 > 7 KSP preconditioned resid norm 1.160670017241e+02 true resid norm 2.821157348522e-06 ||r(i)||/||b|| 2.821157081737e-06 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.447568262216e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.794597825780e+08 at iteration 8 > 8 KSP preconditioned resid norm 6.447568262216e+00 true resid norm 1.516068561348e-07 ||r(i)||/||b|| 1.516068417980e-07 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.135731709822e-15 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.162760088924e-03 at iteration 3 > 3 KSP unpreconditioned resid norm 6.135731709822e-15 true resid norm 1.142020328809e-14 ||r(i)||/||b|| 1.853098793933e-12 > > [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=3 > [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 1.998388224666e-02 near zero implies inconsistent rhs > [0] SNESSolve_NEWTONLS(): fnorm=6.1627600889243711e-03, gnorm=1.0406503258190572e-02, ynorm=6.2999025681245366e+04, lssucceed=0 > 1 2r: 1.04E-02 2x: 3.70E+09 2u: 6.30E+04 ir: 6.54E-03 iu: 5.00E+04 rsn: 0 > [0] SNESComputeJacobian(): Rebuilding preconditioner > > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 1.040650325819e-02 true resid norm 1.040650325819e-02 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 6.758906811264e+07 true resid norm 9.814998431686e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.503922806424e+06 true resid norm 2.275130113021e-01 ||r(i)||/||b|| 2.318013730574e-01 > 2 KSP preconditioned resid norm 3.316753614870e+05 true resid norm 3.820733530238e-02 ||r(i)||/||b|| 3.892750016040e-02 > 3 KSP preconditioned resid norm 2.956751700483e+04 true resid norm 2.143772538677e-03 ||r(i)||/||b|| 2.184180215207e-03 > 4 KSP preconditioned resid norm 1.277067042524e+03 true resid norm 9.093614251311e-05 ||r(i)||/||b|| 9.265018547485e-05 > 5 KSP preconditioned resid norm 1.060996002446e+02 true resid norm 1.042893700050e-05 ||r(i)||/||b|| 1.062551061326e-05 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 5.058127343285e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.758906811264e+07 at iteration 6 > 6 KSP preconditioned resid norm 5.058127343285e+00 true resid norm 4.054770602120e-07 ||r(i)||/||b|| 4.131198420807e-07 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.449606189225e-10 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.040650325819e-02 at iteration 1 > 1 KSP unpreconditioned resid norm 4.449606189225e-10 true resid norm 4.449606189353e-10 ||r(i)||/||b|| 4.275793779098e-08 > > [0] SNESSolve_NEWTONLS(): iter=1, linear solve iterations=1 > [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.300066663571e-02 near zero implies inconsistent rhs > [0] SNESSolve_NEWTONLS(): fnorm=1.0406503258190572e-02, gnorm=7.3566280848133728e-02, ynorm=7.9500485128639993e+04, lssucceed=0 > 2 2r: 7.36E-02 2x: 3.70E+09 2u: 7.95E+04 ir: 4.62E-02 iu: 5.00E+04 rsn: 0 > [0] SNESComputeJacobian(): Rebuilding preconditioner > > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 7.356628084813e-02 true resid norm 7.356628084813e-02 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 7.253424029194e+06 true resid norm 9.647008645250e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.126940190688e+06 true resid norm 1.228009197928e+00 ||r(i)||/||b|| 1.272942984800e+00 > 2 KSP preconditioned resid norm 9.391591432635e+05 true resid norm 7.804929162756e-01 ||r(i)||/||b|| 8.090517433711e-01 > 3 KSP preconditioned resid norm 6.538499674761e+04 true resid norm 5.503467432893e-02 ||r(i)||/||b|| 5.704843475602e-02 > 4 KSP preconditioned resid norm 1.593713396575e+04 true resid norm 8.902701363763e-02 ||r(i)||/||b|| 9.228457951208e-02 > 5 KSP preconditioned resid norm 4.837260621464e+02 true resid norm 2.966772992825e-03 ||r(i)||/||b|| 3.075329464213e-03 > 6 KSP preconditioned resid norm 1.681372767335e+02 true resid norm 5.312467443025e-04 ||r(i)||/||b|| 5.506854651406e-04 > 7 KSP preconditioned resid norm 1.271478850717e+01 true resid norm 2.123810020488e-05 ||r(i)||/||b|| 2.201521838103e-05 > 8 KSP preconditioned resid norm 1.262723712696e+00 true resid norm 1.150572715331e-06 ||r(i)||/||b|| 1.192673042641e-06 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 9.053072585125e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.253424029194e+06 at iteration 9 > 9 KSP preconditioned resid norm 9.053072585125e-02 true resid norm 9.475050575058e-08 ||r(i)||/||b|| 9.821749853747e-08 > 1 KSP unpreconditioned resid norm 8.171589173162e-03 true resid norm 8.171589173162e-03 ||r(i)||/||b|| 1.110779161180e-01 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 4.345765068989e+07 true resid norm 9.999992231691e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.388715093466e+06 true resid norm 8.125387327699e-02 ||r(i)||/||b|| 8.125393639755e-02 > 2 KSP preconditioned resid norm 4.763725726436e+05 true resid norm 2.464285618036e-02 ||r(i)||/||b|| 2.464287532371e-02 > 3 KSP preconditioned resid norm 2.287746683380e+04 true resid norm 7.224823080100e-03 ||r(i)||/||b|| 7.224828692570e-03 > 4 KSP preconditioned resid norm 4.872858764091e+03 true resid norm 3.972261388893e-03 ||r(i)||/||b|| 3.972264474670e-03 > 5 KSP preconditioned resid norm 8.670449895323e+02 true resid norm 2.359005963873e-04 ||r(i)||/||b|| 2.359007796423e-04 > 6 KSP preconditioned resid norm 4.252589693890e+01 true resid norm 1.471904261226e-06 ||r(i)||/||b|| 1.471905404648e-06 > 7 KSP preconditioned resid norm 5.128476471782e+00 true resid norm 1.643725157865e-07 ||r(i)||/||b|| 1.643726434763e-07 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.311901915856e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.345765068989e+07 at iteration 8 > 8 KSP preconditioned resid norm 4.311901915856e-01 true resid norm 1.166123921637e-08 ||r(i)||/||b|| 1.166124827519e-08 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.373662391739e-09 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.356628084813e-02 at iteration 2 > 2 KSP unpreconditioned resid norm 2.373662391739e-09 true resid norm 2.373662391658e-09 ||r(i)||/||b|| 3.226562990941e-08 > > [0] SNESSolve_NEWTONLS(): iter=2, linear solve iterations=2 > [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.343326231305e-02 near zero implies inconsistent rhs > [0] SNESSolve_NEWTONLS(): fnorm=7.3566280848133728e-02, gnorm=7.2259942496422647e-02, ynorm=6.3156901950486099e+04, lssucceed=0 > 3 2r: 7.23E-02 2x: 3.70E+09 2u: 6.32E+04 ir: 4.52E-02 iu: 5.00E+04 rsn: 0 > [0] SNESComputeJacobian(): Rebuilding preconditioner > > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 7.225994249642e-02 true resid norm 7.225994249642e-02 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 7.705582590638e+05 true resid norm 9.649751442741e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.444424220392e+04 true resid norm 8.243110200738e-03 ||r(i)||/||b|| 8.542303135630e-03 > 2 KSP preconditioned resid norm 2.080899648412e+03 true resid norm 7.642343147053e-04 ||r(i)||/||b|| 7.919730567570e-04 > 3 KSP preconditioned resid norm 9.911171129874e+02 true resid norm 5.904182179180e-05 ||r(i)||/||b|| 6.118481096859e-05 > 4 KSP preconditioned resid norm 5.258230282482e+02 true resid norm 2.043366677644e-04 ||r(i)||/||b|| 2.117532964210e-04 > 5 KSP preconditioned resid norm 5.522830460456e+01 true resid norm 1.710780366056e-05 ||r(i)||/||b|| 1.772875059225e-05 > 6 KSP preconditioned resid norm 5.922280741715e+00 true resid norm 1.543198740828e-06 ||r(i)||/||b|| 1.599210870855e-06 > 7 KSP preconditioned resid norm 3.339500859115e-01 true resid norm 1.221335666427e-07 ||r(i)||/||b|| 1.265665414984e-07 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 3.329208597672e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.705582590638e+05 at iteration 8 > 8 KSP preconditioned resid norm 3.329208597672e-02 true resid norm 9.758240835324e-09 ||r(i)||/||b|| 1.011242713683e-08 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.697128456432e-11 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.225994249642e-02 at iteration 1 > 1 KSP unpreconditioned resid norm 2.697128456432e-11 true resid norm 2.697128457142e-11 ||r(i)||/||b|| 3.732536124389e-10 > > [0] SNESSolve_NEWTONLS(): iter=3, linear solve iterations=1 > [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.329227684222e-02 near zero implies inconsistent rhs > [0] SNESSolve_NEWTONLS(): fnorm=7.2259942496422647e-02, gnorm=5.4435602192925014e-01, ynorm=2.7049750229137400e+04, lssucceed=0 > [0] SNESConvergedDefault(): Converged due to small update length: 2.704975022914e+04 < 1.000000000000e-05 * 3.702469482296e+09 > 4 2r: 5.44E-01 2x: 3.70E+09 2u: 2.70E+04 ir: 3.84E-01 iu: 2.34E+04 rsn: stol > Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 4 > > > As the simulation advances this behaviour leads to frequent time step cuts because of 8 subsequently failed Newton iterations, which brings the simulation practically to a halt. > > Is the Block Jacobi not a good choice? Better ASM with huge overlap? Or is there something wrong with my RHS? Maybe the SNES, SNESLS, KSP tolerances need better tuning? > > Grateful for any clarifying words! > Robert > > > My SNES_view is: > > > SNES Object: (flow_) 2 MPI processes > type: newtonls > maximum iterations=8, maximum function evaluations=10000 > tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 > total number of linear solver iterations=1 > total number of function evaluations=2 > norm schedule ALWAYS > SNESLineSearch Object: (flow_) 2 MPI processes > type: basic > maxstep=1.000000e+08, minlambda=1.000000e-05 > tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 > maximum iterations=40 > using user-defined precheck step > KSP Object: (flow_) 2 MPI processes > type: fgmres > GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > GMRES: happy breakdown tolerance 1e-30 > maximum iterations=200, initial guess is zero > tolerances: relative=1e-07, absolute=1e-50, divergence=10000. > right preconditioning > using UNPRECONDITIONED norm type for convergence test > PC Object: (flow_) 2 MPI processes > type: composite > Composite PC type - MULTIPLICATIVE > PCs on composite preconditioner follow > --------------------------------- > PC Object: (flow_sub_0_) 2 MPI processes > type: galerkin > Galerkin PC > KSP on Galerkin follow > --------------------------------- > KSP Object: (flow_sub_0_galerkin_) 2 MPI processes > type: gmres > GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > GMRES: happy breakdown tolerance 1e-30 > maximum iterations=200, initial guess is zero > tolerances: relative=1e-07, absolute=1e-50, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: (flow_sub_0_galerkin_) 2 MPI processes > type: hypre > HYPRE BoomerAMG preconditioning > HYPRE BoomerAMG: Cycle type V > HYPRE BoomerAMG: Maximum number of levels 25 > HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 > HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. > HYPRE BoomerAMG: Threshold for strong coupling 0.25 > HYPRE BoomerAMG: Interpolation truncation factor 0. > HYPRE BoomerAMG: Interpolation: max elements per row 0 > HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 > HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 > HYPRE BoomerAMG: Maximum row sums 0.9 > HYPRE BoomerAMG: Sweeps down 1 > HYPRE BoomerAMG: Sweeps up 1 > HYPRE BoomerAMG: Sweeps on coarse 1 > HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi > HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi > HYPRE BoomerAMG: Relax on coarse Gaussian-elimination > HYPRE BoomerAMG: Relax weight (all) 1. > HYPRE BoomerAMG: Outer relax weight (all) 1. > HYPRE BoomerAMG: Using CF-relaxation > HYPRE BoomerAMG: Not using more complex smoothers. > HYPRE BoomerAMG: Measure type local > HYPRE BoomerAMG: Coarsen type Falgout > HYPRE BoomerAMG: Interpolation type classical > linear system matrix = precond matrix: > Mat Object: 2 MPI processes > type: mpiaij > rows=8000, cols=8000 > total: nonzeros=53600, allocated nonzeros=53600 > total number of mallocs used during MatSetValues calls =0 > not using I-node (on process 0) routines > linear system matrix = precond matrix: > Mat Object: (flow_) 2 MPI processes > type: mpibaij > rows=24000, cols=24000, bs=3 > total: nonzeros=482400, allocated nonzeros=482400 > total number of mallocs used during MatSetValues calls =0 > PC Object: (flow_sub_1_) 2 MPI processes > type: bjacobi > block Jacobi: number of blocks = 2 > Local solve is same for all blocks, in the following KSP and PC objects: > KSP Object: (flow_sub_1_sub_) 1 MPI processes > type: preonly > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. <------ not working: -flow_sub_1_sub_ksp_rtol 1e-7 > left preconditioning > using NONE norm type for convergence test > PC Object: (flow_sub_1_sub_) 1 MPI processes > type: lu > out-of-place factorization > tolerance for zero pivot 2.22045e-14 > matrix ordering: nd > factor fill ratio given 5., needed 18.3108 > Factored matrix follows: > Mat Object: 1 MPI processes > type: seqbaij > rows=12000, cols=12000, bs=3 > package used to perform factorization: petsc > total: nonzeros=4350654, allocated nonzeros=4350654 > total number of mallocs used during MatSetValues calls =0 > block size is 3 > linear system matrix = precond matrix: > Mat Object: (flow_) 1 MPI processes > type: seqbaij > rows=12000, cols=12000, bs=3 > total: nonzeros=237600, allocated nonzeros=237600 > total number of mallocs used during MatSetValues calls =0 > block size is 3 > linear system matrix = precond matrix: > Mat Object: (flow_) 2 MPI processes > type: mpibaij > rows=24000, cols=24000, bs=3 > total: nonzeros=482400, allocated nonzeros=482400 > total number of mallocs used during MatSetValues calls =0 > --------------------------------- > linear system matrix = precond matrix: > Mat Object: (flow_) 2 MPI processes > type: mpibaij > rows=24000, cols=24000, bs=3 > total: nonzeros=482400, allocated nonzeros=482400 > total number of mallocs used during MatSetValues calls =0 From robert.annewandter at opengosim.com Thu Jul 6 17:11:55 2017 From: robert.annewandter at opengosim.com (Robert Annewandter) Date: Thu, 6 Jul 2017 23:11:55 +0100 Subject: [petsc-users] CPR-AMG: SNES with two cores worse than with one In-Reply-To: References: <293da4be-1eaa-9ac0-54fe-171832a5b4af@opengosim.com> Message-ID: Thanks Barry! I've attached log files for np = 1 (SNES time: 218 s) and np = 2 (SNES time: 600 s). PFLOTRAN final output: NP 1 FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 FLOW TS BE Wasted Linear Iterations = 0 FLOW TS BE SNES time = 218.9 seconds NP 2 FLOW TS BE steps = 67 newton = 176 linear = 314 cuts = 13 FLOW TS BE Wasted Linear Iterations = 208 FLOW TS BE SNES time = 600.0 seconds Robert On 06/07/17 21:24, Barry Smith wrote: > So on one process the outer linear solver takes a single iteration this is because the block Jacobi with LU and one block is a direct solver. > >> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 > > On two processes the outer linear solver takes a few iterations to solver, this is to be expected. > > But what you sent doesn't give any indication about SNES not converging. Please turn off all inner linear solver monitoring and just run with -ksp_monitor_true_residual -snes_monitor -snes_lineseach_monitor -snes_converged_reason > > Barry > > > >> On Jul 6, 2017, at 2:03 PM, Robert Annewandter wrote: >> >> Hi all, >> >> I like to understand why the SNES of my CPR-AMG Two-Stage Preconditioner (with KSPFGMRES + multipl. PCComposite (PCGalerkin with KSPGMRES + BoomerAMG, PCBJacobi + PCLU init) on a 24,000 x 24,000 matrix) struggles to converge when using two cores instead of one. Because of the adaptive time stepping of the Newton, this leads to severe cuts in time step. >> >> This is how I run it with two cores >> >> mpirun \ >> -n 2 pflotran \ >> -pflotranin het.pflinput \ >> -ksp_monitor_true_residual \ >> -flow_snes_view \ >> -flow_snes_converged_reason \ >> -flow_sub_1_pc_type bjacobi \ >> -flow_sub_1_sub_pc_type lu \ >> -flow_sub_1_sub_pc_factor_pivot_in_blocks true\ >> -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ >> -options_left \ >> -log_summary \ >> -info >> >> >> With one core I get (after grepping the crap away from -info): >> >> Step 32 Time= 1.80000E+01 >> >> [...] >> >> 0 2r: 1.58E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 7.18E-03 iu: 0.00E+00 rsn: 0 >> [0] SNESComputeJacobian(): Rebuilding preconditioner >> Residual norms for flow_ solve. >> 0 KSP unpreconditioned resid norm 1.581814306485e-02 true resid norm 1.581814306485e-02 ||r(i)||/||b|| 1.000000000000e+00 >> Residual norms for flow_sub_0_galerkin_ solve. >> 0 KSP preconditioned resid norm 5.697603110484e+07 true resid norm 5.175721849125e+03 ||r(i)||/||b|| 5.037527476892e+03 >> 1 KSP preconditioned resid norm 5.041509073319e+06 true resid norm 3.251596928176e+02 ||r(i)||/||b|| 3.164777657484e+02 >> 2 KSP preconditioned resid norm 1.043761838360e+06 true resid norm 8.957519558348e+01 ||r(i)||/||b|| 8.718349288342e+01 >> 3 KSP preconditioned resid norm 1.129189815646e+05 true resid norm 2.722436912053e+00 ||r(i)||/||b|| 2.649746479496e+00 >> 4 KSP preconditioned resid norm 8.829637298082e+04 true resid norm 8.026373593492e+00 ||r(i)||/||b|| 7.812065388300e+00 >> 5 KSP preconditioned resid norm 6.506021637694e+04 true resid norm 3.479889319880e+00 ||r(i)||/||b|| 3.386974527698e+00 >> 6 KSP preconditioned resid norm 6.392263200180e+04 true resid norm 3.819202631980e+00 ||r(i)||/||b|| 3.717228003987e+00 >> 7 KSP preconditioned resid norm 2.464946645480e+04 true resid norm 7.329964753388e-01 ||r(i)||/||b|| 7.134251013911e-01 >> 8 KSP preconditioned resid norm 2.603879153772e+03 true resid norm 2.035525412004e-02 ||r(i)||/||b|| 1.981175861414e-02 >> 9 KSP preconditioned resid norm 1.774410462754e+02 true resid norm 3.001214973121e-03 ||r(i)||/||b|| 2.921081026352e-03 >> 10 KSP preconditioned resid norm 1.664227038378e+01 true resid norm 3.413136309181e-04 ||r(i)||/||b|| 3.322003855903e-04 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 1.131868956745e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 2.067297386780e+07 at iteration 11 >> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 >> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=1 >> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 3.590873180642e-01 near zero implies inconsistent rhs >> [0] SNESSolve_NEWTONLS(): fnorm=1.5818143064846742e-02, gnorm=1.0695649833687331e-02, ynorm=4.6826522561266171e+02, lssucceed=0 >> [0] SNESConvergedDefault(): Converged due to small update length: 4.682652256127e+02 < 1.000000000000e-05 * 3.702480426117e+09 >> 1 2r: 1.07E-02 2x: 3.70E+09 2u: 4.68E+02 ir: 5.05E-03 iu: 4.77E+01 rsn: stol >> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 >> >> >> >> But with two cores I get: >> >> >> Step 32 Time= 1.80000E+01 >> >> [...] >> >> 0 2r: 6.16E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 3.63E-03 iu: 0.00E+00 rsn: 0 >> [0] SNESComputeJacobian(): Rebuilding preconditioner >> >> Residual norms for flow_ solve. >> 0 KSP unpreconditioned resid norm 6.162760088924e-03 true resid norm 6.162760088924e-03 ||r(i)||/||b|| 1.000000000000e+00 >> Residual norms for flow_sub_0_galerkin_ solve. >> 0 KSP preconditioned resid norm 8.994949630499e+08 true resid norm 7.982144380936e-01 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 8.950556502615e+08 true resid norm 1.550138696155e+00 ||r(i)||/||b|| 1.942007839218e+00 >> 2 KSP preconditioned resid norm 1.044849684205e+08 true resid norm 2.166193480531e+00 ||r(i)||/||b|| 2.713798920631e+00 >> 3 KSP preconditioned resid norm 8.209708619718e+06 true resid norm 3.076045005154e-01 ||r(i)||/||b|| 3.853657436340e-01 >> 4 KSP preconditioned resid norm 3.027461352422e+05 true resid norm 1.207731865714e-02 ||r(i)||/||b|| 1.513041869549e-02 >> 5 KSP preconditioned resid norm 1.595302164817e+04 true resid norm 4.123713694368e-04 ||r(i)||/||b|| 5.166172769585e-04 >> 6 KSP preconditioned resid norm 1.898935810797e+03 true resid norm 8.275885058330e-05 ||r(i)||/||b|| 1.036799719897e-04 >> 7 KSP preconditioned resid norm 1.429881682558e+02 true resid norm 4.751240525466e-06 ||r(i)||/||b|| 5.952335987324e-06 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 8.404003313455e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.994949630499e+08 at iteration 8 >> 8 KSP preconditioned resid norm 8.404003313455e+00 true resid norm 3.841921844578e-07 ||r(i)||/||b|| 4.813145016211e-07 >> 1 KSP unpreconditioned resid norm 6.162162548202e-03 true resid norm 6.162162548202e-03 ||r(i)||/||b|| 9.999030400804e-01 >> Residual norms for flow_sub_0_galerkin_ solve. >> 0 KSP preconditioned resid norm 4.360556381209e+07 true resid norm 1.000000245433e+00 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 5.385519331932e+06 true resid norm 8.785183939860e-02 ||r(i)||/||b|| 8.785181783689e-02 >> 2 KSP preconditioned resid norm 4.728931283459e+05 true resid norm 2.008708805316e-02 ||r(i)||/||b|| 2.008708312313e-02 >> 3 KSP preconditioned resid norm 2.734215698319e+04 true resid norm 6.418720397673e-03 ||r(i)||/||b|| 6.418718822309e-03 >> 4 KSP preconditioned resid norm 1.002270029334e+04 true resid norm 4.040289515991e-03 ||r(i)||/||b|| 4.040288524372e-03 >> 5 KSP preconditioned resid norm 1.321280190971e+03 true resid norm 1.023292238313e-04 ||r(i)||/||b|| 1.023291987163e-04 >> 6 KSP preconditioned resid norm 6.594292964815e+01 true resid norm 1.877106733170e-06 ||r(i)||/||b|| 1.877106272467e-06 >> 7 KSP preconditioned resid norm 7.816325147216e+00 true resid norm 2.552611664980e-07 ||r(i)||/||b|| 2.552611038486e-07 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.391568446109e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.360556381209e+07 at iteration 8 >> 8 KSP preconditioned resid norm 6.391568446109e-01 true resid norm 1.680724939670e-08 ||r(i)||/||b|| 1.680724527166e-08 >> 2 KSP unpreconditioned resid norm 4.328902922753e-07 true resid norm 4.328902922752e-07 ||r(i)||/||b|| 7.024292460341e-05 >> Residual norms for flow_sub_0_galerkin_ solve. >> 0 KSP preconditioned resid norm 8.794597825780e+08 true resid norm 1.000000094566e+00 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 8.609906572102e+08 true resid norm 2.965044981249e+00 ||r(i)||/||b|| 2.965044700856e+00 >> 2 KSP preconditioned resid norm 9.318108989314e+07 true resid norm 1.881262939380e+00 ||r(i)||/||b|| 1.881262761477e+00 >> 3 KSP preconditioned resid norm 6.908723262483e+06 true resid norm 2.639592490398e-01 ||r(i)||/||b|| 2.639592240782e-01 >> 4 KSP preconditioned resid norm 2.651677791227e+05 true resid norm 9.736480169584e-03 ||r(i)||/||b|| 9.736479248845e-03 >> 5 KSP preconditioned resid norm 1.192178471172e+04 true resid norm 3.082839752692e-04 ||r(i)||/||b|| 3.082839461160e-04 >> 6 KSP preconditioned resid norm 1.492201446262e+03 true resid norm 4.633866284506e-05 ||r(i)||/||b|| 4.633865846301e-05 >> 7 KSP preconditioned resid norm 1.160670017241e+02 true resid norm 2.821157348522e-06 ||r(i)||/||b|| 2.821157081737e-06 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.447568262216e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.794597825780e+08 at iteration 8 >> 8 KSP preconditioned resid norm 6.447568262216e+00 true resid norm 1.516068561348e-07 ||r(i)||/||b|| 1.516068417980e-07 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.135731709822e-15 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.162760088924e-03 at iteration 3 >> 3 KSP unpreconditioned resid norm 6.135731709822e-15 true resid norm 1.142020328809e-14 ||r(i)||/||b|| 1.853098793933e-12 >> >> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=3 >> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 1.998388224666e-02 near zero implies inconsistent rhs >> [0] SNESSolve_NEWTONLS(): fnorm=6.1627600889243711e-03, gnorm=1.0406503258190572e-02, ynorm=6.2999025681245366e+04, lssucceed=0 >> 1 2r: 1.04E-02 2x: 3.70E+09 2u: 6.30E+04 ir: 6.54E-03 iu: 5.00E+04 rsn: 0 >> [0] SNESComputeJacobian(): Rebuilding preconditioner >> >> Residual norms for flow_ solve. >> 0 KSP unpreconditioned resid norm 1.040650325819e-02 true resid norm 1.040650325819e-02 ||r(i)||/||b|| 1.000000000000e+00 >> Residual norms for flow_sub_0_galerkin_ solve. >> 0 KSP preconditioned resid norm 6.758906811264e+07 true resid norm 9.814998431686e-01 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 2.503922806424e+06 true resid norm 2.275130113021e-01 ||r(i)||/||b|| 2.318013730574e-01 >> 2 KSP preconditioned resid norm 3.316753614870e+05 true resid norm 3.820733530238e-02 ||r(i)||/||b|| 3.892750016040e-02 >> 3 KSP preconditioned resid norm 2.956751700483e+04 true resid norm 2.143772538677e-03 ||r(i)||/||b|| 2.184180215207e-03 >> 4 KSP preconditioned resid norm 1.277067042524e+03 true resid norm 9.093614251311e-05 ||r(i)||/||b|| 9.265018547485e-05 >> 5 KSP preconditioned resid norm 1.060996002446e+02 true resid norm 1.042893700050e-05 ||r(i)||/||b|| 1.062551061326e-05 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 5.058127343285e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.758906811264e+07 at iteration 6 >> 6 KSP preconditioned resid norm 5.058127343285e+00 true resid norm 4.054770602120e-07 ||r(i)||/||b|| 4.131198420807e-07 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.449606189225e-10 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.040650325819e-02 at iteration 1 >> 1 KSP unpreconditioned resid norm 4.449606189225e-10 true resid norm 4.449606189353e-10 ||r(i)||/||b|| 4.275793779098e-08 >> >> [0] SNESSolve_NEWTONLS(): iter=1, linear solve iterations=1 >> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.300066663571e-02 near zero implies inconsistent rhs >> [0] SNESSolve_NEWTONLS(): fnorm=1.0406503258190572e-02, gnorm=7.3566280848133728e-02, ynorm=7.9500485128639993e+04, lssucceed=0 >> 2 2r: 7.36E-02 2x: 3.70E+09 2u: 7.95E+04 ir: 4.62E-02 iu: 5.00E+04 rsn: 0 >> [0] SNESComputeJacobian(): Rebuilding preconditioner >> >> Residual norms for flow_ solve. >> 0 KSP unpreconditioned resid norm 7.356628084813e-02 true resid norm 7.356628084813e-02 ||r(i)||/||b|| 1.000000000000e+00 >> Residual norms for flow_sub_0_galerkin_ solve. >> 0 KSP preconditioned resid norm 7.253424029194e+06 true resid norm 9.647008645250e-01 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 7.126940190688e+06 true resid norm 1.228009197928e+00 ||r(i)||/||b|| 1.272942984800e+00 >> 2 KSP preconditioned resid norm 9.391591432635e+05 true resid norm 7.804929162756e-01 ||r(i)||/||b|| 8.090517433711e-01 >> 3 KSP preconditioned resid norm 6.538499674761e+04 true resid norm 5.503467432893e-02 ||r(i)||/||b|| 5.704843475602e-02 >> 4 KSP preconditioned resid norm 1.593713396575e+04 true resid norm 8.902701363763e-02 ||r(i)||/||b|| 9.228457951208e-02 >> 5 KSP preconditioned resid norm 4.837260621464e+02 true resid norm 2.966772992825e-03 ||r(i)||/||b|| 3.075329464213e-03 >> 6 KSP preconditioned resid norm 1.681372767335e+02 true resid norm 5.312467443025e-04 ||r(i)||/||b|| 5.506854651406e-04 >> 7 KSP preconditioned resid norm 1.271478850717e+01 true resid norm 2.123810020488e-05 ||r(i)||/||b|| 2.201521838103e-05 >> 8 KSP preconditioned resid norm 1.262723712696e+00 true resid norm 1.150572715331e-06 ||r(i)||/||b|| 1.192673042641e-06 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 9.053072585125e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.253424029194e+06 at iteration 9 >> 9 KSP preconditioned resid norm 9.053072585125e-02 true resid norm 9.475050575058e-08 ||r(i)||/||b|| 9.821749853747e-08 >> 1 KSP unpreconditioned resid norm 8.171589173162e-03 true resid norm 8.171589173162e-03 ||r(i)||/||b|| 1.110779161180e-01 >> Residual norms for flow_sub_0_galerkin_ solve. >> 0 KSP preconditioned resid norm 4.345765068989e+07 true resid norm 9.999992231691e-01 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 5.388715093466e+06 true resid norm 8.125387327699e-02 ||r(i)||/||b|| 8.125393639755e-02 >> 2 KSP preconditioned resid norm 4.763725726436e+05 true resid norm 2.464285618036e-02 ||r(i)||/||b|| 2.464287532371e-02 >> 3 KSP preconditioned resid norm 2.287746683380e+04 true resid norm 7.224823080100e-03 ||r(i)||/||b|| 7.224828692570e-03 >> 4 KSP preconditioned resid norm 4.872858764091e+03 true resid norm 3.972261388893e-03 ||r(i)||/||b|| 3.972264474670e-03 >> 5 KSP preconditioned resid norm 8.670449895323e+02 true resid norm 2.359005963873e-04 ||r(i)||/||b|| 2.359007796423e-04 >> 6 KSP preconditioned resid norm 4.252589693890e+01 true resid norm 1.471904261226e-06 ||r(i)||/||b|| 1.471905404648e-06 >> 7 KSP preconditioned resid norm 5.128476471782e+00 true resid norm 1.643725157865e-07 ||r(i)||/||b|| 1.643726434763e-07 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.311901915856e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.345765068989e+07 at iteration 8 >> 8 KSP preconditioned resid norm 4.311901915856e-01 true resid norm 1.166123921637e-08 ||r(i)||/||b|| 1.166124827519e-08 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.373662391739e-09 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.356628084813e-02 at iteration 2 >> 2 KSP unpreconditioned resid norm 2.373662391739e-09 true resid norm 2.373662391658e-09 ||r(i)||/||b|| 3.226562990941e-08 >> >> [0] SNESSolve_NEWTONLS(): iter=2, linear solve iterations=2 >> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.343326231305e-02 near zero implies inconsistent rhs >> [0] SNESSolve_NEWTONLS(): fnorm=7.3566280848133728e-02, gnorm=7.2259942496422647e-02, ynorm=6.3156901950486099e+04, lssucceed=0 >> 3 2r: 7.23E-02 2x: 3.70E+09 2u: 6.32E+04 ir: 4.52E-02 iu: 5.00E+04 rsn: 0 >> [0] SNESComputeJacobian(): Rebuilding preconditioner >> >> Residual norms for flow_ solve. >> 0 KSP unpreconditioned resid norm 7.225994249642e-02 true resid norm 7.225994249642e-02 ||r(i)||/||b|| 1.000000000000e+00 >> Residual norms for flow_sub_0_galerkin_ solve. >> 0 KSP preconditioned resid norm 7.705582590638e+05 true resid norm 9.649751442741e-01 ||r(i)||/||b|| 1.000000000000e+00 >> 1 KSP preconditioned resid norm 2.444424220392e+04 true resid norm 8.243110200738e-03 ||r(i)||/||b|| 8.542303135630e-03 >> 2 KSP preconditioned resid norm 2.080899648412e+03 true resid norm 7.642343147053e-04 ||r(i)||/||b|| 7.919730567570e-04 >> 3 KSP preconditioned resid norm 9.911171129874e+02 true resid norm 5.904182179180e-05 ||r(i)||/||b|| 6.118481096859e-05 >> 4 KSP preconditioned resid norm 5.258230282482e+02 true resid norm 2.043366677644e-04 ||r(i)||/||b|| 2.117532964210e-04 >> 5 KSP preconditioned resid norm 5.522830460456e+01 true resid norm 1.710780366056e-05 ||r(i)||/||b|| 1.772875059225e-05 >> 6 KSP preconditioned resid norm 5.922280741715e+00 true resid norm 1.543198740828e-06 ||r(i)||/||b|| 1.599210870855e-06 >> 7 KSP preconditioned resid norm 3.339500859115e-01 true resid norm 1.221335666427e-07 ||r(i)||/||b|| 1.265665414984e-07 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 3.329208597672e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.705582590638e+05 at iteration 8 >> 8 KSP preconditioned resid norm 3.329208597672e-02 true resid norm 9.758240835324e-09 ||r(i)||/||b|| 1.011242713683e-08 >> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.697128456432e-11 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.225994249642e-02 at iteration 1 >> 1 KSP unpreconditioned resid norm 2.697128456432e-11 true resid norm 2.697128457142e-11 ||r(i)||/||b|| 3.732536124389e-10 >> >> [0] SNESSolve_NEWTONLS(): iter=3, linear solve iterations=1 >> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.329227684222e-02 near zero implies inconsistent rhs >> [0] SNESSolve_NEWTONLS(): fnorm=7.2259942496422647e-02, gnorm=5.4435602192925014e-01, ynorm=2.7049750229137400e+04, lssucceed=0 >> [0] SNESConvergedDefault(): Converged due to small update length: 2.704975022914e+04 < 1.000000000000e-05 * 3.702469482296e+09 >> 4 2r: 5.44E-01 2x: 3.70E+09 2u: 2.70E+04 ir: 3.84E-01 iu: 2.34E+04 rsn: stol >> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 4 >> >> >> As the simulation advances this behaviour leads to frequent time step cuts because of 8 subsequently failed Newton iterations, which brings the simulation practically to a halt. >> >> Is the Block Jacobi not a good choice? Better ASM with huge overlap? Or is there something wrong with my RHS? Maybe the SNES, SNESLS, KSP tolerances need better tuning? >> >> Grateful for any clarifying words! >> Robert >> >> >> My SNES_view is: >> >> >> SNES Object: (flow_) 2 MPI processes >> type: newtonls >> maximum iterations=8, maximum function evaluations=10000 >> tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 >> total number of linear solver iterations=1 >> total number of function evaluations=2 >> norm schedule ALWAYS >> SNESLineSearch Object: (flow_) 2 MPI processes >> type: basic >> maxstep=1.000000e+08, minlambda=1.000000e-05 >> tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 >> maximum iterations=40 >> using user-defined precheck step >> KSP Object: (flow_) 2 MPI processes >> type: fgmres >> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >> GMRES: happy breakdown tolerance 1e-30 >> maximum iterations=200, initial guess is zero >> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >> right preconditioning >> using UNPRECONDITIONED norm type for convergence test >> PC Object: (flow_) 2 MPI processes >> type: composite >> Composite PC type - MULTIPLICATIVE >> PCs on composite preconditioner follow >> --------------------------------- >> PC Object: (flow_sub_0_) 2 MPI processes >> type: galerkin >> Galerkin PC >> KSP on Galerkin follow >> --------------------------------- >> KSP Object: (flow_sub_0_galerkin_) 2 MPI processes >> type: gmres >> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >> GMRES: happy breakdown tolerance 1e-30 >> maximum iterations=200, initial guess is zero >> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >> left preconditioning >> using PRECONDITIONED norm type for convergence test >> PC Object: (flow_sub_0_galerkin_) 2 MPI processes >> type: hypre >> HYPRE BoomerAMG preconditioning >> HYPRE BoomerAMG: Cycle type V >> HYPRE BoomerAMG: Maximum number of levels 25 >> HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 >> HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. >> HYPRE BoomerAMG: Threshold for strong coupling 0.25 >> HYPRE BoomerAMG: Interpolation truncation factor 0. >> HYPRE BoomerAMG: Interpolation: max elements per row 0 >> HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 >> HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 >> HYPRE BoomerAMG: Maximum row sums 0.9 >> HYPRE BoomerAMG: Sweeps down 1 >> HYPRE BoomerAMG: Sweeps up 1 >> HYPRE BoomerAMG: Sweeps on coarse 1 >> HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi >> HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi >> HYPRE BoomerAMG: Relax on coarse Gaussian-elimination >> HYPRE BoomerAMG: Relax weight (all) 1. >> HYPRE BoomerAMG: Outer relax weight (all) 1. >> HYPRE BoomerAMG: Using CF-relaxation >> HYPRE BoomerAMG: Not using more complex smoothers. >> HYPRE BoomerAMG: Measure type local >> HYPRE BoomerAMG: Coarsen type Falgout >> HYPRE BoomerAMG: Interpolation type classical >> linear system matrix = precond matrix: >> Mat Object: 2 MPI processes >> type: mpiaij >> rows=8000, cols=8000 >> total: nonzeros=53600, allocated nonzeros=53600 >> total number of mallocs used during MatSetValues calls =0 >> not using I-node (on process 0) routines >> linear system matrix = precond matrix: >> Mat Object: (flow_) 2 MPI processes >> type: mpibaij >> rows=24000, cols=24000, bs=3 >> total: nonzeros=482400, allocated nonzeros=482400 >> total number of mallocs used during MatSetValues calls =0 >> PC Object: (flow_sub_1_) 2 MPI processes >> type: bjacobi >> block Jacobi: number of blocks = 2 >> Local solve is same for all blocks, in the following KSP and PC objects: >> KSP Object: (flow_sub_1_sub_) 1 MPI processes >> type: preonly >> maximum iterations=10000, initial guess is zero >> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. <------ not working: -flow_sub_1_sub_ksp_rtol 1e-7 >> left preconditioning >> using NONE norm type for convergence test >> PC Object: (flow_sub_1_sub_) 1 MPI processes >> type: lu >> out-of-place factorization >> tolerance for zero pivot 2.22045e-14 >> matrix ordering: nd >> factor fill ratio given 5., needed 18.3108 >> Factored matrix follows: >> Mat Object: 1 MPI processes >> type: seqbaij >> rows=12000, cols=12000, bs=3 >> package used to perform factorization: petsc >> total: nonzeros=4350654, allocated nonzeros=4350654 >> total number of mallocs used during MatSetValues calls =0 >> block size is 3 >> linear system matrix = precond matrix: >> Mat Object: (flow_) 1 MPI processes >> type: seqbaij >> rows=12000, cols=12000, bs=3 >> total: nonzeros=237600, allocated nonzeros=237600 >> total number of mallocs used during MatSetValues calls =0 >> block size is 3 >> linear system matrix = precond matrix: >> Mat Object: (flow_) 2 MPI processes >> type: mpibaij >> rows=24000, cols=24000, bs=3 >> total: nonzeros=482400, allocated nonzeros=482400 >> total number of mallocs used during MatSetValues calls =0 >> --------------------------------- >> linear system matrix = precond matrix: >> Mat Object: (flow_) 2 MPI processes >> type: mpibaij >> rows=24000, cols=24000, bs=3 >> total: nonzeros=482400, allocated nonzeros=482400 >> total number of mallocs used during MatSetValues calls =0 -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: het_np_1.log Type: text/x-log Size: 49743 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: het_np_2.log Type: text/x-log Size: 133957 bytes Desc: not available URL: From bsmith at mcs.anl.gov Thu Jul 6 19:20:27 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Thu, 6 Jul 2017 19:20:27 -0500 Subject: [petsc-users] CPR-AMG: SNES with two cores worse than with one In-Reply-To: References: <293da4be-1eaa-9ac0-54fe-171832a5b4af@opengosim.com> Message-ID: Looks like PFLOTRAN has a maximum number of SNES iterations as 8 and cuts the timestep if that fails. Please run with -snes_monitor I don't understand the strange densely packed information that PFLOTRAN is printing. It looks like the linear solver is converging fine in parallel, normally then there is absolutely no reason that the Newton should behave different on 2 processors than 1 unless there is something wrong with the Jacobian. What is the -pc_type for the two cases LU or your fancy thing? Please run sequential and parallel with -pc_type lu and also with -snes_monitor. We need to fix all the knobs but one in order to understand what is going on. Barry > On Jul 6, 2017, at 5:11 PM, Robert Annewandter wrote: > > Thanks Barry! > > I've attached log files for np = 1 (SNES time: 218 s) and np = 2 (SNES time: 600 s). PFLOTRAN final output: > > NP 1 > > FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 > FLOW TS BE Wasted Linear Iterations = 0 > FLOW TS BE SNES time = 218.9 seconds > > NP 2 > > FLOW TS BE steps = 67 newton = 176 linear = 314 cuts = 13 > FLOW TS BE Wasted Linear Iterations = 208 > FLOW TS BE SNES time = 600.0 seconds > > > Robert > > On 06/07/17 21:24, Barry Smith wrote: >> So on one process the outer linear solver takes a single iteration this is because the block Jacobi with LU and one block is a direct solver. >> >> >>> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >>> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 >>> >> >> On two processes the outer linear solver takes a few iterations to solver, this is to be expected. >> >> But what you sent doesn't give any indication about SNES not converging. Please turn off all inner linear solver monitoring and just run with -ksp_monitor_true_residual -snes_monitor -snes_lineseach_monitor -snes_converged_reason >> >> Barry >> >> >> >> >>> On Jul 6, 2017, at 2:03 PM, Robert Annewandter >>> wrote: >>> >>> Hi all, >>> >>> I like to understand why the SNES of my CPR-AMG Two-Stage Preconditioner (with KSPFGMRES + multipl. PCComposite (PCGalerkin with KSPGMRES + BoomerAMG, PCBJacobi + PCLU init) on a 24,000 x 24,000 matrix) struggles to converge when using two cores instead of one. Because of the adaptive time stepping of the Newton, this leads to severe cuts in time step. >>> >>> This is how I run it with two cores >>> >>> mpirun \ >>> -n 2 pflotran \ >>> -pflotranin het.pflinput \ >>> -ksp_monitor_true_residual \ >>> -flow_snes_view \ >>> -flow_snes_converged_reason \ >>> -flow_sub_1_pc_type bjacobi \ >>> -flow_sub_1_sub_pc_type lu \ >>> -flow_sub_1_sub_pc_factor_pivot_in_blocks true\ >>> -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ >>> -options_left \ >>> -log_summary \ >>> -info >>> >>> >>> With one core I get (after grepping the crap away from -info): >>> >>> Step 32 Time= 1.80000E+01 >>> >>> [...] >>> >>> 0 2r: 1.58E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 7.18E-03 iu: 0.00E+00 rsn: 0 >>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>> Residual norms for flow_ solve. >>> 0 KSP unpreconditioned resid norm 1.581814306485e-02 true resid norm 1.581814306485e-02 ||r(i)||/||b|| 1.000000000000e+00 >>> Residual norms for flow_sub_0_galerkin_ solve. >>> 0 KSP preconditioned resid norm 5.697603110484e+07 true resid norm 5.175721849125e+03 ||r(i)||/||b|| 5.037527476892e+03 >>> 1 KSP preconditioned resid norm 5.041509073319e+06 true resid norm 3.251596928176e+02 ||r(i)||/||b|| 3.164777657484e+02 >>> 2 KSP preconditioned resid norm 1.043761838360e+06 true resid norm 8.957519558348e+01 ||r(i)||/||b|| 8.718349288342e+01 >>> 3 KSP preconditioned resid norm 1.129189815646e+05 true resid norm 2.722436912053e+00 ||r(i)||/||b|| 2.649746479496e+00 >>> 4 KSP preconditioned resid norm 8.829637298082e+04 true resid norm 8.026373593492e+00 ||r(i)||/||b|| 7.812065388300e+00 >>> 5 KSP preconditioned resid norm 6.506021637694e+04 true resid norm 3.479889319880e+00 ||r(i)||/||b|| 3.386974527698e+00 >>> 6 KSP preconditioned resid norm 6.392263200180e+04 true resid norm 3.819202631980e+00 ||r(i)||/||b|| 3.717228003987e+00 >>> 7 KSP preconditioned resid norm 2.464946645480e+04 true resid norm 7.329964753388e-01 ||r(i)||/||b|| 7.134251013911e-01 >>> 8 KSP preconditioned resid norm 2.603879153772e+03 true resid norm 2.035525412004e-02 ||r(i)||/||b|| 1.981175861414e-02 >>> 9 KSP preconditioned resid norm 1.774410462754e+02 true resid norm 3.001214973121e-03 ||r(i)||/||b|| 2.921081026352e-03 >>> 10 KSP preconditioned resid norm 1.664227038378e+01 true resid norm 3.413136309181e-04 ||r(i)||/||b|| 3.322003855903e-04 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 1.131868956745e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 2.067297386780e+07 at iteration 11 >>> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >>> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 >>> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=1 >>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 3.590873180642e-01 near zero implies inconsistent rhs >>> [0] SNESSolve_NEWTONLS(): fnorm=1.5818143064846742e-02, gnorm=1.0695649833687331e-02, ynorm=4.6826522561266171e+02, lssucceed=0 >>> [0] SNESConvergedDefault(): Converged due to small update length: 4.682652256127e+02 < 1.000000000000e-05 * 3.702480426117e+09 >>> 1 2r: 1.07E-02 2x: 3.70E+09 2u: 4.68E+02 ir: 5.05E-03 iu: 4.77E+01 rsn: stol >>> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 >>> >>> >>> >>> But with two cores I get: >>> >>> >>> Step 32 Time= 1.80000E+01 >>> >>> [...] >>> >>> 0 2r: 6.16E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 3.63E-03 iu: 0.00E+00 rsn: 0 >>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>> >>> Residual norms for flow_ solve. >>> 0 KSP unpreconditioned resid norm 6.162760088924e-03 true resid norm 6.162760088924e-03 ||r(i)||/||b|| 1.000000000000e+00 >>> Residual norms for flow_sub_0_galerkin_ solve. >>> 0 KSP preconditioned resid norm 8.994949630499e+08 true resid norm 7.982144380936e-01 ||r(i)||/||b|| 1.000000000000e+00 >>> 1 KSP preconditioned resid norm 8.950556502615e+08 true resid norm 1.550138696155e+00 ||r(i)||/||b|| 1.942007839218e+00 >>> 2 KSP preconditioned resid norm 1.044849684205e+08 true resid norm 2.166193480531e+00 ||r(i)||/||b|| 2.713798920631e+00 >>> 3 KSP preconditioned resid norm 8.209708619718e+06 true resid norm 3.076045005154e-01 ||r(i)||/||b|| 3.853657436340e-01 >>> 4 KSP preconditioned resid norm 3.027461352422e+05 true resid norm 1.207731865714e-02 ||r(i)||/||b|| 1.513041869549e-02 >>> 5 KSP preconditioned resid norm 1.595302164817e+04 true resid norm 4.123713694368e-04 ||r(i)||/||b|| 5.166172769585e-04 >>> 6 KSP preconditioned resid norm 1.898935810797e+03 true resid norm 8.275885058330e-05 ||r(i)||/||b|| 1.036799719897e-04 >>> 7 KSP preconditioned resid norm 1.429881682558e+02 true resid norm 4.751240525466e-06 ||r(i)||/||b|| 5.952335987324e-06 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 8.404003313455e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.994949630499e+08 at iteration 8 >>> 8 KSP preconditioned resid norm 8.404003313455e+00 true resid norm 3.841921844578e-07 ||r(i)||/||b|| 4.813145016211e-07 >>> 1 KSP unpreconditioned resid norm 6.162162548202e-03 true resid norm 6.162162548202e-03 ||r(i)||/||b|| 9.999030400804e-01 >>> Residual norms for flow_sub_0_galerkin_ solve. >>> 0 KSP preconditioned resid norm 4.360556381209e+07 true resid norm 1.000000245433e+00 ||r(i)||/||b|| 1.000000000000e+00 >>> 1 KSP preconditioned resid norm 5.385519331932e+06 true resid norm 8.785183939860e-02 ||r(i)||/||b|| 8.785181783689e-02 >>> 2 KSP preconditioned resid norm 4.728931283459e+05 true resid norm 2.008708805316e-02 ||r(i)||/||b|| 2.008708312313e-02 >>> 3 KSP preconditioned resid norm 2.734215698319e+04 true resid norm 6.418720397673e-03 ||r(i)||/||b|| 6.418718822309e-03 >>> 4 KSP preconditioned resid norm 1.002270029334e+04 true resid norm 4.040289515991e-03 ||r(i)||/||b|| 4.040288524372e-03 >>> 5 KSP preconditioned resid norm 1.321280190971e+03 true resid norm 1.023292238313e-04 ||r(i)||/||b|| 1.023291987163e-04 >>> 6 KSP preconditioned resid norm 6.594292964815e+01 true resid norm 1.877106733170e-06 ||r(i)||/||b|| 1.877106272467e-06 >>> 7 KSP preconditioned resid norm 7.816325147216e+00 true resid norm 2.552611664980e-07 ||r(i)||/||b|| 2.552611038486e-07 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.391568446109e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.360556381209e+07 at iteration 8 >>> 8 KSP preconditioned resid norm 6.391568446109e-01 true resid norm 1.680724939670e-08 ||r(i)||/||b|| 1.680724527166e-08 >>> 2 KSP unpreconditioned resid norm 4.328902922753e-07 true resid norm 4.328902922752e-07 ||r(i)||/||b|| 7.024292460341e-05 >>> Residual norms for flow_sub_0_galerkin_ solve. >>> 0 KSP preconditioned resid norm 8.794597825780e+08 true resid norm 1.000000094566e+00 ||r(i)||/||b|| 1.000000000000e+00 >>> 1 KSP preconditioned resid norm 8.609906572102e+08 true resid norm 2.965044981249e+00 ||r(i)||/||b|| 2.965044700856e+00 >>> 2 KSP preconditioned resid norm 9.318108989314e+07 true resid norm 1.881262939380e+00 ||r(i)||/||b|| 1.881262761477e+00 >>> 3 KSP preconditioned resid norm 6.908723262483e+06 true resid norm 2.639592490398e-01 ||r(i)||/||b|| 2.639592240782e-01 >>> 4 KSP preconditioned resid norm 2.651677791227e+05 true resid norm 9.736480169584e-03 ||r(i)||/||b|| 9.736479248845e-03 >>> 5 KSP preconditioned resid norm 1.192178471172e+04 true resid norm 3.082839752692e-04 ||r(i)||/||b|| 3.082839461160e-04 >>> 6 KSP preconditioned resid norm 1.492201446262e+03 true resid norm 4.633866284506e-05 ||r(i)||/||b|| 4.633865846301e-05 >>> 7 KSP preconditioned resid norm 1.160670017241e+02 true resid norm 2.821157348522e-06 ||r(i)||/||b|| 2.821157081737e-06 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.447568262216e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.794597825780e+08 at iteration 8 >>> 8 KSP preconditioned resid norm 6.447568262216e+00 true resid norm 1.516068561348e-07 ||r(i)||/||b|| 1.516068417980e-07 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.135731709822e-15 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.162760088924e-03 at iteration 3 >>> 3 KSP unpreconditioned resid norm 6.135731709822e-15 true resid norm 1.142020328809e-14 ||r(i)||/||b|| 1.853098793933e-12 >>> >>> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=3 >>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 1.998388224666e-02 near zero implies inconsistent rhs >>> [0] SNESSolve_NEWTONLS(): fnorm=6.1627600889243711e-03, gnorm=1.0406503258190572e-02, ynorm=6.2999025681245366e+04, lssucceed=0 >>> 1 2r: 1.04E-02 2x: 3.70E+09 2u: 6.30E+04 ir: 6.54E-03 iu: 5.00E+04 rsn: 0 >>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>> >>> Residual norms for flow_ solve. >>> 0 KSP unpreconditioned resid norm 1.040650325819e-02 true resid norm 1.040650325819e-02 ||r(i)||/||b|| 1.000000000000e+00 >>> Residual norms for flow_sub_0_galerkin_ solve. >>> 0 KSP preconditioned resid norm 6.758906811264e+07 true resid norm 9.814998431686e-01 ||r(i)||/||b|| 1.000000000000e+00 >>> 1 KSP preconditioned resid norm 2.503922806424e+06 true resid norm 2.275130113021e-01 ||r(i)||/||b|| 2.318013730574e-01 >>> 2 KSP preconditioned resid norm 3.316753614870e+05 true resid norm 3.820733530238e-02 ||r(i)||/||b|| 3.892750016040e-02 >>> 3 KSP preconditioned resid norm 2.956751700483e+04 true resid norm 2.143772538677e-03 ||r(i)||/||b|| 2.184180215207e-03 >>> 4 KSP preconditioned resid norm 1.277067042524e+03 true resid norm 9.093614251311e-05 ||r(i)||/||b|| 9.265018547485e-05 >>> 5 KSP preconditioned resid norm 1.060996002446e+02 true resid norm 1.042893700050e-05 ||r(i)||/||b|| 1.062551061326e-05 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 5.058127343285e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.758906811264e+07 at iteration 6 >>> 6 KSP preconditioned resid norm 5.058127343285e+00 true resid norm 4.054770602120e-07 ||r(i)||/||b|| 4.131198420807e-07 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.449606189225e-10 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.040650325819e-02 at iteration 1 >>> 1 KSP unpreconditioned resid norm 4.449606189225e-10 true resid norm 4.449606189353e-10 ||r(i)||/||b|| 4.275793779098e-08 >>> >>> [0] SNESSolve_NEWTONLS(): iter=1, linear solve iterations=1 >>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.300066663571e-02 near zero implies inconsistent rhs >>> [0] SNESSolve_NEWTONLS(): fnorm=1.0406503258190572e-02, gnorm=7.3566280848133728e-02, ynorm=7.9500485128639993e+04, lssucceed=0 >>> 2 2r: 7.36E-02 2x: 3.70E+09 2u: 7.95E+04 ir: 4.62E-02 iu: 5.00E+04 rsn: 0 >>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>> >>> Residual norms for flow_ solve. >>> 0 KSP unpreconditioned resid norm 7.356628084813e-02 true resid norm 7.356628084813e-02 ||r(i)||/||b|| 1.000000000000e+00 >>> Residual norms for flow_sub_0_galerkin_ solve. >>> 0 KSP preconditioned resid norm 7.253424029194e+06 true resid norm 9.647008645250e-01 ||r(i)||/||b|| 1.000000000000e+00 >>> 1 KSP preconditioned resid norm 7.126940190688e+06 true resid norm 1.228009197928e+00 ||r(i)||/||b|| 1.272942984800e+00 >>> 2 KSP preconditioned resid norm 9.391591432635e+05 true resid norm 7.804929162756e-01 ||r(i)||/||b|| 8.090517433711e-01 >>> 3 KSP preconditioned resid norm 6.538499674761e+04 true resid norm 5.503467432893e-02 ||r(i)||/||b|| 5.704843475602e-02 >>> 4 KSP preconditioned resid norm 1.593713396575e+04 true resid norm 8.902701363763e-02 ||r(i)||/||b|| 9.228457951208e-02 >>> 5 KSP preconditioned resid norm 4.837260621464e+02 true resid norm 2.966772992825e-03 ||r(i)||/||b|| 3.075329464213e-03 >>> 6 KSP preconditioned resid norm 1.681372767335e+02 true resid norm 5.312467443025e-04 ||r(i)||/||b|| 5.506854651406e-04 >>> 7 KSP preconditioned resid norm 1.271478850717e+01 true resid norm 2.123810020488e-05 ||r(i)||/||b|| 2.201521838103e-05 >>> 8 KSP preconditioned resid norm 1.262723712696e+00 true resid norm 1.150572715331e-06 ||r(i)||/||b|| 1.192673042641e-06 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 9.053072585125e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.253424029194e+06 at iteration 9 >>> 9 KSP preconditioned resid norm 9.053072585125e-02 true resid norm 9.475050575058e-08 ||r(i)||/||b|| 9.821749853747e-08 >>> 1 KSP unpreconditioned resid norm 8.171589173162e-03 true resid norm 8.171589173162e-03 ||r(i)||/||b|| 1.110779161180e-01 >>> Residual norms for flow_sub_0_galerkin_ solve. >>> 0 KSP preconditioned resid norm 4.345765068989e+07 true resid norm 9.999992231691e-01 ||r(i)||/||b|| 1.000000000000e+00 >>> 1 KSP preconditioned resid norm 5.388715093466e+06 true resid norm 8.125387327699e-02 ||r(i)||/||b|| 8.125393639755e-02 >>> 2 KSP preconditioned resid norm 4.763725726436e+05 true resid norm 2.464285618036e-02 ||r(i)||/||b|| 2.464287532371e-02 >>> 3 KSP preconditioned resid norm 2.287746683380e+04 true resid norm 7.224823080100e-03 ||r(i)||/||b|| 7.224828692570e-03 >>> 4 KSP preconditioned resid norm 4.872858764091e+03 true resid norm 3.972261388893e-03 ||r(i)||/||b|| 3.972264474670e-03 >>> 5 KSP preconditioned resid norm 8.670449895323e+02 true resid norm 2.359005963873e-04 ||r(i)||/||b|| 2.359007796423e-04 >>> 6 KSP preconditioned resid norm 4.252589693890e+01 true resid norm 1.471904261226e-06 ||r(i)||/||b|| 1.471905404648e-06 >>> 7 KSP preconditioned resid norm 5.128476471782e+00 true resid norm 1.643725157865e-07 ||r(i)||/||b|| 1.643726434763e-07 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.311901915856e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.345765068989e+07 at iteration 8 >>> 8 KSP preconditioned resid norm 4.311901915856e-01 true resid norm 1.166123921637e-08 ||r(i)||/||b|| 1.166124827519e-08 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.373662391739e-09 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.356628084813e-02 at iteration 2 >>> 2 KSP unpreconditioned resid norm 2.373662391739e-09 true resid norm 2.373662391658e-09 ||r(i)||/||b|| 3.226562990941e-08 >>> >>> [0] SNESSolve_NEWTONLS(): iter=2, linear solve iterations=2 >>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.343326231305e-02 near zero implies inconsistent rhs >>> [0] SNESSolve_NEWTONLS(): fnorm=7.3566280848133728e-02, gnorm=7.2259942496422647e-02, ynorm=6.3156901950486099e+04, lssucceed=0 >>> 3 2r: 7.23E-02 2x: 3.70E+09 2u: 6.32E+04 ir: 4.52E-02 iu: 5.00E+04 rsn: 0 >>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>> >>> Residual norms for flow_ solve. >>> 0 KSP unpreconditioned resid norm 7.225994249642e-02 true resid norm 7.225994249642e-02 ||r(i)||/||b|| 1.000000000000e+00 >>> Residual norms for flow_sub_0_galerkin_ solve. >>> 0 KSP preconditioned resid norm 7.705582590638e+05 true resid norm 9.649751442741e-01 ||r(i)||/||b|| 1.000000000000e+00 >>> 1 KSP preconditioned resid norm 2.444424220392e+04 true resid norm 8.243110200738e-03 ||r(i)||/||b|| 8.542303135630e-03 >>> 2 KSP preconditioned resid norm 2.080899648412e+03 true resid norm 7.642343147053e-04 ||r(i)||/||b|| 7.919730567570e-04 >>> 3 KSP preconditioned resid norm 9.911171129874e+02 true resid norm 5.904182179180e-05 ||r(i)||/||b|| 6.118481096859e-05 >>> 4 KSP preconditioned resid norm 5.258230282482e+02 true resid norm 2.043366677644e-04 ||r(i)||/||b|| 2.117532964210e-04 >>> 5 KSP preconditioned resid norm 5.522830460456e+01 true resid norm 1.710780366056e-05 ||r(i)||/||b|| 1.772875059225e-05 >>> 6 KSP preconditioned resid norm 5.922280741715e+00 true resid norm 1.543198740828e-06 ||r(i)||/||b|| 1.599210870855e-06 >>> 7 KSP preconditioned resid norm 3.339500859115e-01 true resid norm 1.221335666427e-07 ||r(i)||/||b|| 1.265665414984e-07 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 3.329208597672e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.705582590638e+05 at iteration 8 >>> 8 KSP preconditioned resid norm 3.329208597672e-02 true resid norm 9.758240835324e-09 ||r(i)||/||b|| 1.011242713683e-08 >>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.697128456432e-11 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.225994249642e-02 at iteration 1 >>> 1 KSP unpreconditioned resid norm 2.697128456432e-11 true resid norm 2.697128457142e-11 ||r(i)||/||b|| 3.732536124389e-10 >>> >>> [0] SNESSolve_NEWTONLS(): iter=3, linear solve iterations=1 >>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.329227684222e-02 near zero implies inconsistent rhs >>> [0] SNESSolve_NEWTONLS(): fnorm=7.2259942496422647e-02, gnorm=5.4435602192925014e-01, ynorm=2.7049750229137400e+04, lssucceed=0 >>> [0] SNESConvergedDefault(): Converged due to small update length: 2.704975022914e+04 < 1.000000000000e-05 * 3.702469482296e+09 >>> 4 2r: 5.44E-01 2x: 3.70E+09 2u: 2.70E+04 ir: 3.84E-01 iu: 2.34E+04 rsn: stol >>> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 4 >>> >>> >>> As the simulation advances this behaviour leads to frequent time step cuts because of 8 subsequently failed Newton iterations, which brings the simulation practically to a halt. >>> >>> Is the Block Jacobi not a good choice? Better ASM with huge overlap? Or is there something wrong with my RHS? Maybe the SNES, SNESLS, KSP tolerances need better tuning? >>> >>> Grateful for any clarifying words! >>> Robert >>> >>> >>> My SNES_view is: >>> >>> >>> SNES Object: (flow_) 2 MPI processes >>> type: newtonls >>> maximum iterations=8, maximum function evaluations=10000 >>> tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 >>> total number of linear solver iterations=1 >>> total number of function evaluations=2 >>> norm schedule ALWAYS >>> SNESLineSearch Object: (flow_) 2 MPI processes >>> type: basic >>> maxstep=1.000000e+08, minlambda=1.000000e-05 >>> tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 >>> maximum iterations=40 >>> using user-defined precheck step >>> KSP Object: (flow_) 2 MPI processes >>> type: fgmres >>> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >>> GMRES: happy breakdown tolerance 1e-30 >>> maximum iterations=200, initial guess is zero >>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>> right preconditioning >>> using UNPRECONDITIONED norm type for convergence test >>> PC Object: (flow_) 2 MPI processes >>> type: composite >>> Composite PC type - MULTIPLICATIVE >>> PCs on composite preconditioner follow >>> --------------------------------- >>> PC Object: (flow_sub_0_) 2 MPI processes >>> type: galerkin >>> Galerkin PC >>> KSP on Galerkin follow >>> --------------------------------- >>> KSP Object: (flow_sub_0_galerkin_) 2 MPI processes >>> type: gmres >>> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >>> GMRES: happy breakdown tolerance 1e-30 >>> maximum iterations=200, initial guess is zero >>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>> left preconditioning >>> using PRECONDITIONED norm type for convergence test >>> PC Object: (flow_sub_0_galerkin_) 2 MPI processes >>> type: hypre >>> HYPRE BoomerAMG preconditioning >>> HYPRE BoomerAMG: Cycle type V >>> HYPRE BoomerAMG: Maximum number of levels 25 >>> HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 >>> HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. >>> HYPRE BoomerAMG: Threshold for strong coupling 0.25 >>> HYPRE BoomerAMG: Interpolation truncation factor 0. >>> HYPRE BoomerAMG: Interpolation: max elements per row 0 >>> HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 >>> HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 >>> HYPRE BoomerAMG: Maximum row sums 0.9 >>> HYPRE BoomerAMG: Sweeps down 1 >>> HYPRE BoomerAMG: Sweeps up 1 >>> HYPRE BoomerAMG: Sweeps on coarse 1 >>> HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi >>> HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi >>> HYPRE BoomerAMG: Relax on coarse Gaussian-elimination >>> HYPRE BoomerAMG: Relax weight (all) 1. >>> HYPRE BoomerAMG: Outer relax weight (all) 1. >>> HYPRE BoomerAMG: Using CF-relaxation >>> HYPRE BoomerAMG: Not using more complex smoothers. >>> HYPRE BoomerAMG: Measure type local >>> HYPRE BoomerAMG: Coarsen type Falgout >>> HYPRE BoomerAMG: Interpolation type classical >>> linear system matrix = precond matrix: >>> Mat Object: 2 MPI processes >>> type: mpiaij >>> rows=8000, cols=8000 >>> total: nonzeros=53600, allocated nonzeros=53600 >>> total number of mallocs used during MatSetValues calls =0 >>> not using I-node (on process 0) routines >>> linear system matrix = precond matrix: >>> Mat Object: (flow_) 2 MPI processes >>> type: mpibaij >>> rows=24000, cols=24000, bs=3 >>> total: nonzeros=482400, allocated nonzeros=482400 >>> total number of mallocs used during MatSetValues calls =0 >>> PC Object: (flow_sub_1_) 2 MPI processes >>> type: bjacobi >>> block Jacobi: number of blocks = 2 >>> Local solve is same for all blocks, in the following KSP and PC objects: >>> KSP Object: (flow_sub_1_sub_) 1 MPI processes >>> type: preonly >>> maximum iterations=10000, initial guess is zero >>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. <------ not working: -flow_sub_1_sub_ksp_rtol 1e-7 >>> left preconditioning >>> using NONE norm type for convergence test >>> PC Object: (flow_sub_1_sub_) 1 MPI processes >>> type: lu >>> out-of-place factorization >>> tolerance for zero pivot 2.22045e-14 >>> matrix ordering: nd >>> factor fill ratio given 5., needed 18.3108 >>> Factored matrix follows: >>> Mat Object: 1 MPI processes >>> type: seqbaij >>> rows=12000, cols=12000, bs=3 >>> package used to perform factorization: petsc >>> total: nonzeros=4350654, allocated nonzeros=4350654 >>> total number of mallocs used during MatSetValues calls =0 >>> block size is 3 >>> linear system matrix = precond matrix: >>> Mat Object: (flow_) 1 MPI processes >>> type: seqbaij >>> rows=12000, cols=12000, bs=3 >>> total: nonzeros=237600, allocated nonzeros=237600 >>> total number of mallocs used during MatSetValues calls =0 >>> block size is 3 >>> linear system matrix = precond matrix: >>> Mat Object: (flow_) 2 MPI processes >>> type: mpibaij >>> rows=24000, cols=24000, bs=3 >>> total: nonzeros=482400, allocated nonzeros=482400 >>> total number of mallocs used during MatSetValues calls =0 >>> --------------------------------- >>> linear system matrix = precond matrix: >>> Mat Object: (flow_) 2 MPI processes >>> type: mpibaij >>> rows=24000, cols=24000, bs=3 >>> total: nonzeros=482400, allocated nonzeros=482400 >>> total number of mallocs used during MatSetValues calls =0 >>> > > From mailinglists at xgm.de Fri Jul 7 04:31:45 2017 From: mailinglists at xgm.de (Florian Lindner) Date: Fri, 7 Jul 2017 17:31:45 +0800 Subject: [petsc-users] Understanding preallocation for MPI Message-ID: Hello, I'm having some struggle understanding the preallocation for MPIAIJ matrices, especially when a value is in off-diagonal vs. diagonal block. The small example program is at https://pastebin.com/67dXnGm3 In general it should be parallel, but right now I just run it in serial. According to my understanding of http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/Mat/MatMPIAIJSetPreallocation.html a entry is in the diagonal submatrix, if its row is in the OwnershipRange and its column is in OwnershipRangeColumn. That also means that in a serial run, there is only a diagonal submatrix. However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when Inserting 6 elements in row 2, though I have exactly 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal submatrix of row 2) Error is: [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: New nonzero at (2,5) caused a malloc Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn off this check What is wrong with my understanding? Thanks, Florian From dave.mayhem23 at gmail.com Fri Jul 7 04:49:39 2017 From: dave.mayhem23 at gmail.com (Dave May) Date: Fri, 07 Jul 2017 09:49:39 +0000 Subject: [petsc-users] Understanding preallocation for MPI In-Reply-To: References: Message-ID: On Fri, 7 Jul 2017 at 11:31, Florian Lindner wrote: > Hello, > > I'm having some struggle understanding the preallocation for MPIAIJ > matrices, especially when a value is in off-diagonal > vs. diagonal block. > > The small example program is at https://pastebin.com/67dXnGm3 > > In general it should be parallel, but right now I just run it in serial. When you run this code in serial, the mat type will be MATSEQAIJ. Hence, the call to MatMPIAIJSetPreallocation() will have no effect because the mat type does not match MPIAIJ. As a result, your code doesn't perform any preallocation for SEQAIJ matrices. In addition to calling MatMPIAIJSetPreallocation(), add a call to MatSEQAIJSetPreallocation. Thanks, Dave > > According to my understanding of > > > http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/Mat/MatMPIAIJSetPreallocation.html > > a entry is in the diagonal submatrix, if its row is in the OwnershipRange > and its column is in OwnershipRangeColumn. > That also means that in a serial run, there is only a diagonal submatrix. > > However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when > > Inserting 6 elements in row 2, though I have exactly > > 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal > submatrix of row 2) > > Error is: > > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: New nonzero at (2,5) caused a malloc > Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn > off this check > > > What is wrong with my understanding? > > Thanks, > Florian > -------------- next part -------------- An HTML attachment was scrubbed... URL: From imilian.hartig at gmail.com Fri Jul 7 04:54:21 2017 From: imilian.hartig at gmail.com (Maximilian Hartig) Date: Fri, 7 Jul 2017 11:54:21 +0200 Subject: [petsc-users] -snes_fd for problems with residuals with non-continuous first derivative? In-Reply-To: <8EEBC84F-F0BB-4E7F-9FAA-8D35B86A15BC@mcs.anl.gov> References: <8EEBC84F-F0BB-4E7F-9FAA-8D35B86A15BC@mcs.anl.gov> Message-ID: If I set the function count higher it results in a diverged line search error. And if I reduce the absolute residual tolerance it continues for one or two more timesteps before it fails again. Thanks, Max 2017-07-05 20:24 GMT+02:00 Barry Smith : > > > 39 SNES Function norm 3.758101652998e-08 > > 0 KSP preconditioned resid norm 1.931834799209e-02 true resid norm > 3.758101652998e-08 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 5.958979968059e-16 true resid norm > 2.588244438237e-18 ||r(i)||/||b|| 6.887105983875e-11 > > The SNES function norm is pretty small here are you sure you need it > smaller. > > > Nonlinear solve did not converge due to DIVERGED_FUNCTION_COUNT i > > You should just set the function count to say 1 billion so it doesn't > stop the solution process. > > > > > > On Jul 5, 2017, at 11:24 AM, Maximilian Hartig > wrote: > > > > The solver goes on for some timesteps, then it gets hung up in step 10. > The output is as follows: > > > > 28 SNES Function norm 7.825649542035e-06 > > 0 KSP preconditioned resid norm 5.335581451751e+00 true resid norm > 7.825649542035e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 3.875747966342e-13 true resid norm > 3.082821236889e-15 ||r(i)||/||b|| 3.939380648635e-10 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 29 SNES Function norm 7.825641650401e-06 > > 0 KSP preconditioned resid norm 5.335568660325e+00 true resid norm > 7.825641650401e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 1.169064646930e-13 true resid norm > 2.949237553452e-15 ||r(i)||/||b|| 3.768684646199e-10 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 30 SNES Function norm 7.825633758775e-06 > > 0 KSP preconditioned resid norm 5.335575714181e+00 true resid norm > 7.825633758775e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 3.626528075820e-13 true resid norm > 7.454935467844e-16 ||r(i)||/||b|| 9.526302530432e-11 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 31 SNES Function norm 7.825625867144e-06 > > 0 KSP preconditioned resid norm 5.335574289757e+00 true resid norm > 7.825625867144e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 1.220021201426e-13 true resid norm > 6.140701297052e-16 ||r(i)||/||b|| 7.846913973787e-11 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 32 SNES Function norm 7.825617975525e-06 > > 0 KSP preconditioned resid norm 5.335556211708e+00 true resid norm > 7.825617975525e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 3.238615954344e-14 true resid norm > 1.639170816829e-15 ||r(i)||/||b|| 2.094621564655e-10 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 33 SNES Function norm 7.825610083913e-06 > > 0 KSP preconditioned resid norm 5.335545135100e+00 true resid norm > 7.825610083913e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 8.328043430360e-14 true resid norm > 7.902728010647e-16 ||r(i)||/||b|| 1.009854557780e-10 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 34 SNES Function norm 7.825609294752e-06 > > 0 KSP preconditioned resid norm 5.335519330054e+00 true resid norm > 7.825609294752e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 1.176339150741e-13 true resid norm > 2.137240765649e-15 ||r(i)||/||b|| 2.731085446703e-10 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 35 SNES Function norm 7.825608505592e-06 > > 0 KSP preconditioned resid norm 5.335552250936e+00 true resid norm > 7.825608505592e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 2.388837462586e-13 true resid norm > 3.899327292367e-16 ||r(i)||/||b|| 4.982778386601e-11 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 36 SNES Function norm 7.825607716432e-06 > > 0 KSP preconditioned resid norm 1.017554264638e-01 true resid norm > 7.825607716432e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 2.758703070887e-14 true resid norm > 1.990491888342e-16 ||r(i)||/||b|| 2.543562059932e-11 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 37 SNES Function norm 3.815837655573e-08 > > 0 KSP preconditioned resid norm 7.197730150406e+00 true resid norm > 3.815837655573e-08 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 7.114599045039e-12 true resid norm > 4.763264085142e-16 ||r(i)||/||b|| 1.248287929175e-08 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 38 SNES Function norm 3.790245121284e-08 > > 0 KSP preconditioned resid norm 7.127517791828e+00 true resid norm > 3.790245121284e-08 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 2.500976336448e-11 true resid norm > 1.692661771456e-15 ||r(i)||/||b|| 4.465837214461e-08 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 39 SNES Function norm 3.758101652998e-08 > > 0 KSP preconditioned resid norm 1.931834799209e-02 true resid norm > 3.758101652998e-08 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 5.958979968059e-16 true resid norm > 2.588244438237e-18 ||r(i)||/||b|| 6.887105983875e-11 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Nonlinear solve did not converge due to DIVERGED_FUNCTION_COUNT > iterations 39 > > [0]PETSC ERROR: --------------------- Error Message > -------------------------------------------------------------- > > [0]PETSC ERROR: > > [0]PETSC ERROR: TSStep has failed due to DIVERGED_NONLINEAR_SOLVE, > increase -ts_max_snes_failures or make negative to attempt recovery > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html > for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.7.5-3342-gb122798 > GIT Date: 2017-03-22 17:42:51 -0500 > > [0]PETSC ERROR: ./miniFEM on a arch-linux2-c-debug named iket127138 by > hartig Wed Jul 5 18:09:53 2017 > > [0]PETSC ERROR: Configure options PETSC_ARCH=arch-linux2-c-debug > --with-cc=mpigcc --with-cxx=mpicxx --with-fc=mpif90 --download-ml > --download-parmetis --download-metis --download-hypre --download-mumps > --download-scalapack > > [0]PETSC ERROR: #1 TSStep() line 3818 in /home/hartig/petsc/src/ts/ > interface/ts.c > > [0]PETSC ERROR: #2 TSSolve() line 4054 in /home/hartig/petsc/src/ts/ > interface/ts.c > > [0]PETSC ERROR: #3 main() line 1829 in /home/hartig/Nextcloud/ > Dissertation/Code/Debugging/miniFEM.c > > [0]PETSC ERROR: PETSc Option Table entries: > > [0]PETSC ERROR: -def_petscspace_order 2 > > [0]PETSC ERROR: -eplast_petscspace_order 2 > > [0]PETSC ERROR: -ksp_converged_reason > > [0]PETSC ERROR: -ksp_monitor_true_residual > > [0]PETSC ERROR: -pc_type lu > > [0]PETSC ERROR: -plast > > [0]PETSC ERROR: -snes_converged_reason > > [0]PETSC ERROR: -snes_fd > > [0]PETSC ERROR: -snes_monitor > > [0]PETSC ERROR: -snes_type newtonls > > [0]PETSC ERROR: -ts_monitor > > [0]PETSC ERROR: -vel_petscspace_order 2 > > [0]PETSC ERROR: ----------------End of Error Message -------send entire > error message to petsc-maint at mcs.anl.gov---------- > > > > > > Thanks, > > Max > > > > > > 2017-06-30 17:14 GMT+02:00 Barry Smith : > > > > What is the output from > > > > -snes_monitor -ksp_monitor_true_residual -pc_type lu > -ksp_converged_reason -snes_converged_reason > > > > > > > On Jun 30, 2017, at 3:45 AM, Maximilian Hartig < > imilian.hartig at gmail.com> wrote: > > > > > > Hello, > > > > > > I?m trying to implement plasticity and have problems getting the Petsc > SNES to converge. To check if my residual formulation is correct I tried > running with -snes_fd for an easy example as the Petsc FAQ suggest. I > cannot seem to get the solver to converge at any cost. > > > I already tried to impose bounds on the solution and moved to > vinewtonrsls as a nonlinear solver. I checked and rechecked my residuals > but I do not find an error there. I now have the suspicion that the > -snes_fd option is not made for handling residuals who?s first derivatives > are not continuous (e.g. have an ?if? condition in them for the plasticity/ > flow-condition). Can you confirm my suspicion? And is there another way to > test my residual formulation separate from my hand-coded jacobian? > > > > > > > > > Thanks, > > > Max > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From imilian.hartig at gmail.com Fri Jul 7 05:10:37 2017 From: imilian.hartig at gmail.com (Maximilian Hartig) Date: Fri, 7 Jul 2017 12:10:37 +0200 Subject: [petsc-users] -snes_fd for problems with residuals with non-continuous first derivative? In-Reply-To: <12F4A94C-BA00-4293-B5B6-9D3631CF9D03@gmail.com> References: <87978294-9B3A-46C3-9986-6CA2B90891FD@gmail.com> <02c4a0fc-534e-0e4b-6955-8edfb0b85dda@berkeley.edu> <12F4A94C-BA00-4293-B5B6-9D3631CF9D03@gmail.com> Message-ID: I have looked into several books for plasticity, but it cannot hurt to check out another one. I will do so as soon as I can get a hold of it. I do have a basic understanding on how to implement plasticity with the return mapping algorithm. My main problem is that I am lost when trying to implement it within Petsc. I just might have to create two separate snes -solver contexts to run inside a single TS solver. In my understanding, that is not how Petsc is designed to work though. I cannot seem to find a clear formulation for dynamic plasticity either. I looked into the Cristescu book "dynamic plasticity" but that was not very helpful either. I have read through: Rust, W. (2009). Nichtlineare Finite- Elemente-Berechnungen. Wiesbaden: Springer Vieweg. Kim, N.-H. (2015). Introduction to Nonlinear Finite Element Analysis. New York, NY: Springer New York Heidelberg Dodrecht London. http://doi.org/10.1007/978-1-4419-1746-1 Steinke, P. (2015). Finite-Elemente-Methode (5th ed.). Springer Vieweg. and they all describe how to set up a stationary (or pseudo-timestepping) solver for plasticity. But firstly I'd like to avoid writing my own solver and secondly I need it to be transient. I have looked at the links you provided Luv, thanks. DAMASK is to complex a subject for me to understand it quickly. I will need some time to understand what it does and how to make use of it exactly. Thanks, Max 2017-07-05 20:49 GMT+02:00 Luv Sharma : > Hi , > > I agree with Sanjay and you can still look at the links that I mentioned; > to get an understanding of different plasticity formulations. > Honestly, I am also lost in plasticity ;) > > The first link is an FFT based spectral solver implementation of > plasticity. > I have a PETSc implementation (in python) of the same but without > plasticity (only hyper-elasticity). I hope to make it open source soon. > May be that will be helpful for you as well! > > Best regards, > Luv > > On 5 Jul 2017, at 19:08, Sanjay Govindjee wrote: > > Let me suggest that you grab a hold of Simo and Hughes, Computational > Inelasticity, Springer-Verlag (1998). It explains a lot about how to set > up this problem -- in particular Chapter 1 gives a comprehensive > one-dimensional tutorial on everything you need to know. > > > On 7/5/17 9:39 AM, Maximilian Hartig wrote: > > I do not clearly understand the discrimination between local and global > plasticity. I do have areas where I expect the behaviour to be elastic and > other areas where I expect elasto-plastic behaviour. > Inertia effects are of importance and hence I need second order temporal > derivatives of my displacements. The only way I have found to implement > this in Petsc is to create a separate velocity field which I use to then > compute ?. > To account for plasticity, in my understanding I need to introduce at > least one additional history variable. In my case this is the effective > plastic strain e_p. I then solve the equation of motion > (grad(sigma)-rho*?+F=0) and the consistency condition (sigma_eq - > sigma_yield = 0) at the same time. Or try to at least. > > Thanks, > Max > > 2017-06-30 20:49 GMT+02:00 Luv Sharma : > >> Hi Max, >> >> I do not understand the equations that you write very clearly. >> >> Are you looking to implement a ?local? and ?if? type of isotropic >> hardening plasticity? If that is the case, then in my understanding you >> need to solve only 1 field equation for the displacement components or for >> the strain components. You can look at the following code: >> https://github.com/tdegeus/GooseFFT/blob/master/small-strain >> /laminate/elasto-plasticity.py >> >> If you are looking for a PETSc based implementation for plasticity >> (isotropic/anisotropic) you can look at >> https://damask.mpie.de/ >> I had presented a talk about the same at the PETSc User Meeting last year. >> >> As I understand it, additional field equations will only be necessary if >> the plasticity or elasticity were ?nonlocal?. You may want to look at: >> On the role of moving elastic?plastic boundaries in strain gradient >> plasticity, R H J Peerlings >> >> Best regards, >> Luv >> >> On 30 Jun 2017, at 11:52, Maximilian Hartig >> wrote: >> >> Hi Luv, >> >> I?m modelling linear hardening(sigma_y = sigma_y0 + >> K_iso*epsilon_plast_eqiv) with isotropic plasticity only. So I should not >> need to use an iterative method to find the point on the yield surface. I >> have three fields and 7 unknowns in total: >> Field 0: 3 displacement components >> Field 1: 3 velocity components >> Field 2: 1 equivalent plastic strain >> >> It is the solver for these three fields that is not converging. I am >> using PetscFE. As residuals for the plastic case (sigma_vM > sigma_yield) I >> have: >> >> Field 0 (displacement): >> f0[i] = rho*u_t[u_Off[1]+i] >> f1[i*dim+j] = sigma_tr[i*dim+j] - 2*mu*sqrt(3/2)*u_t[uOff[2]]*N[i*dim+j] >> >> where sigma_tr is the trial stress, mu is the shear modulus and N is the >> unit deviator tensor normal to the yield surface. >> >> Field 1 (velocity): >> f0[i] = u[uOff[1]+i]-u_t[i] >> f1[i*dim+j] = 0 >> >> Field 2 (effective plastic strain): >> f0[0] = ||s_tr|| -2*mu*sqrt(3/2)*u_t[uOff[2]]-sqrt(2/3)*sigma_y >> f1[i] = 0 >> where ||s_tr|| is the norm of the deviator stress tensor. >> >> Field 0 residual is essentially newton?s second law of motion and Field 2 >> residual should be the yield criterion. I might have just fundamentally >> misunderstood the equations of plasticity but I cannot seem to find my >> mistake. >> >> Thanks, >> Max >> >> >> On 30. Jun 2017, at 11:09, Luv Sharma wrote: >> >> Hi Max, >> >> Is your field solver not converging or the material point solver ;)? >> >> Best regards, >> Luv >> >> On 30 Jun 2017, at 10:45, Maximilian Hartig >> wrote: >> >> Hello, >> >> I?m trying to implement plasticity and have problems getting the Petsc >> SNES to converge. To check if my residual formulation is correct I tried >> running with -snes_fd for an easy example as the Petsc FAQ suggest. I >> cannot seem to get the solver to converge at any cost. >> I already tried to impose bounds on the solution and moved to >> vinewtonrsls as a nonlinear solver. I checked and rechecked my residuals >> but I do not find an error there. I now have the suspicion that the >> -snes_fd option is not made for handling residuals who?s first derivatives >> are not continuous (e.g. have an ?if? condition in them for the plasticity/ >> flow-condition). Can you confirm my suspicion? And is there another way to >> test my residual formulation separate from my hand-coded jacobian? >> >> >> Thanks, >> Max >> >> >> >> >> > > -- > ------------------------------------------------------------------- > Sanjay Govindjee, PhD, PE > Horace, Dorothy, and Katherine Johnson Professor in Engineering > > 779 Davis Hall > University of California > Berkeley, CA 94720-1710 > > Voice: +1 510 642 6060 <(510)%20642-6060> > FAX: +1 510 643 5264 <(510)%20643-5264>s_g at berkeley.eduhttp://faculty.ce.berkeley.edu/sanjay > ------------------------------------------------------------------- > > Books: > > Engineering Mechanics of Deformable > Solids: A Presentation with Exerciseshttp://www.oup.com/us/catalog/general/subject/Physics/MaterialsScience/?view=usa&ci=9780199651641http://ukcatalogue.oup.com/product/9780199651641.dohttp://amzn.com/0199651647 > > Engineering Mechanics 3 (Dynamics) 2nd Editionhttp://www.springer.com/978-3-642-53711-0http://amzn.com/3642537111 > > Engineering Mechanics 3, Supplementary Problems: Dynamics http://www.amzn.com/B00SOXN8JU > > ----------------------------------------------- > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From imilian.hartig at gmail.com Fri Jul 7 05:19:25 2017 From: imilian.hartig at gmail.com (Maximilian Hartig) Date: Fri, 7 Jul 2017 12:19:25 +0200 Subject: [petsc-users] -snes_fd for problems with residuals with non-continuous first derivative? In-Reply-To: References: <87978294-9B3A-46C3-9986-6CA2B90891FD@gmail.com> Message-ID: We do have one second order timestepper (Newmark) put in by Lisandro Great, I was not aware of that. I'll try to make use of it as soon as I resolve this issue. I have a suspicion that my problem is the fact that I'm updating my plastic strain during the nonlinear solver iterations for the stress. I tried to create an auxiliary field for the plastic strain and then update it at the end of each timestep with PEtscDSSetUpdate. But the update function does not seem to get called. Do I have to update the auxiliary field in a TSMonitor context? I couldn't find any examples of how to update an Auxiliary field. Thanks, Max 2017-07-05 18:46 GMT+02:00 Matthew Knepley : > On Wed, Jul 5, 2017 at 9:39 AM, Maximilian Hartig < > imilian.hartig at gmail.com> wrote: > >> I do not clearly understand the discrimination between local and global >> plasticity. I do have areas where I expect the behaviour to be elastic and >> other areas where I expect elasto-plastic behaviour. >> Inertia effects are of importance and hence I need second order temporal >> derivatives of my displacements. The only way I have found to implement >> this in Petsc is to create a separate velocity field which I use to then >> compute ?. >> > > We do have one second order timestepper (Newmark) put in by Lisandro: > > http://www.mcs.anl.gov/petsc/petsc-current/docs/ > manualpages/TS/TSALPHA2.html > > >> To account for plasticity, in my understanding I need to introduce at >> least one additional history variable. In my case this is the effective >> plastic strain e_p. I then solve the equation of motion >> (grad(sigma)-rho*?+F=0) and the consistency condition (sigma_eq - >> sigma_yield = 0) at the same time. Or try to at least. >> > > Did you look at the DAMASK formulation that Luv suggested? > > Thanks, > > Matt > > >> Thanks, >> Max >> >> 2017-06-30 20:49 GMT+02:00 Luv Sharma : >> >>> Hi Max, >>> >>> I do not understand the equations that you write very clearly. >>> >>> Are you looking to implement a ?local? and ?if? type of isotropic >>> hardening plasticity? If that is the case, then in my understanding you >>> need to solve only 1 field equation for the displacement components or for >>> the strain components. You can look at the following code: >>> https://github.com/tdegeus/GooseFFT/blob/master/small-strain >>> /laminate/elasto-plasticity.py >>> >>> If you are looking for a PETSc based implementation for plasticity >>> (isotropic/anisotropic) you can look at >>> https://damask.mpie.de/ >>> I had presented a talk about the same at the PETSc User Meeting last >>> year. >>> >>> As I understand it, additional field equations will only be necessary if >>> the plasticity or elasticity were ?nonlocal?. You may want to look at: >>> On the role of moving elastic?plastic boundaries in strain gradient >>> plasticity, R H J Peerlings >>> >>> Best regards, >>> Luv >>> >>> On 30 Jun 2017, at 11:52, Maximilian Hartig >>> wrote: >>> >>> Hi Luv, >>> >>> I?m modelling linear hardening(sigma_y = sigma_y0 + >>> K_iso*epsilon_plast_eqiv) with isotropic plasticity only. So I should not >>> need to use an iterative method to find the point on the yield surface. I >>> have three fields and 7 unknowns in total: >>> Field 0: 3 displacement components >>> Field 1: 3 velocity components >>> Field 2: 1 equivalent plastic strain >>> >>> It is the solver for these three fields that is not converging. I am >>> using PetscFE. As residuals for the plastic case (sigma_vM > sigma_yield) I >>> have: >>> >>> Field 0 (displacement): >>> f0[i] = rho*u_t[u_Off[1]+i] >>> f1[i*dim+j] = sigma_tr[i*dim+j] - 2*mu*sqrt(3/2)*u_t[uOff[2]]*N[i*dim+j] >>> >>> where sigma_tr is the trial stress, mu is the shear modulus and N is the >>> unit deviator tensor normal to the yield surface. >>> >>> Field 1 (velocity): >>> f0[i] = u[uOff[1]+i]-u_t[i] >>> f1[i*dim+j] = 0 >>> >>> Field 2 (effective plastic strain): >>> f0[0] = ||s_tr|| -2*mu*sqrt(3/2)*u_t[uOff[2]]-sqrt(2/3)*sigma_y >>> f1[i] = 0 >>> where ||s_tr|| is the norm of the deviator stress tensor. >>> >>> Field 0 residual is essentially newton?s second law of motion and Field >>> 2 residual should be the yield criterion. I might have just fundamentally >>> misunderstood the equations of plasticity but I cannot seem to find my >>> mistake. >>> >>> Thanks, >>> Max >>> >>> >>> On 30. Jun 2017, at 11:09, Luv Sharma wrote: >>> >>> Hi Max, >>> >>> Is your field solver not converging or the material point solver ;)? >>> >>> Best regards, >>> Luv >>> >>> On 30 Jun 2017, at 10:45, Maximilian Hartig >>> wrote: >>> >>> Hello, >>> >>> I?m trying to implement plasticity and have problems getting the Petsc >>> SNES to converge. To check if my residual formulation is correct I tried >>> running with -snes_fd for an easy example as the Petsc FAQ suggest. I >>> cannot seem to get the solver to converge at any cost. >>> I already tried to impose bounds on the solution and moved to >>> vinewtonrsls as a nonlinear solver. I checked and rechecked my residuals >>> but I do not find an error there. I now have the suspicion that the >>> -snes_fd option is not made for handling residuals who?s first derivatives >>> are not continuous (e.g. have an ?if? condition in them for the plasticity/ >>> flow-condition). Can you confirm my suspicion? And is there another way to >>> test my residual formulation separate from my hand-coded jacobian? >>> >>> >>> Thanks, >>> Max >>> >>> >>> >>> >>> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ > -------------- next part -------------- An HTML attachment was scrubbed... URL: From robert.annewandter at opengosim.com Fri Jul 7 06:05:34 2017 From: robert.annewandter at opengosim.com (Robert Annewandter) Date: Fri, 7 Jul 2017 12:05:34 +0100 Subject: [petsc-users] CPR-AMG: SNES with two cores worse than with one In-Reply-To: References: <293da4be-1eaa-9ac0-54fe-171832a5b4af@opengosim.com> Message-ID: <981f495d-529c-88be-bdaa-4db736e7f357@opengosim.com> Yes indeed, PFLOTRAN cuts timestep after 8 failed iterations of SNES. I've rerun with -snes_monitor (attached with canonical suffix), their -pc_type is always PCBJACOBI + PCLU (though we'd like to try SUPERLU in the future, however it works only with -mat_type aij..) The sequential and parallel runs I did with -ksp_type preonly -pc_type lu -pc_factor_nonzeros_along_diagonal -snes_monitor and -ksp_type preonly -pc_type bjacobi -sub_pc_type lu -sub_pc_factor_nonzeros_along_diagonal -snes_monitor As expected, the sequential are bot identical and the parallel takes half the time compared to sequential. On 07/07/17 01:20, Barry Smith wrote: > Looks like PFLOTRAN has a maximum number of SNES iterations as 8 and cuts the timestep if that fails. > > Please run with -snes_monitor I don't understand the strange densely packed information that PFLOTRAN is printing. > > It looks like the linear solver is converging fine in parallel, normally then there is absolutely no reason that the Newton should behave different on 2 processors than 1 unless there is something wrong with the Jacobian. What is the -pc_type for the two cases LU or your fancy thing? > > Please run sequential and parallel with -pc_type lu and also with -snes_monitor. We need to fix all the knobs but one in order to understand what is going on. > > > Barry > > > >> On Jul 6, 2017, at 5:11 PM, Robert Annewandter wrote: >> >> Thanks Barry! >> >> I've attached log files for np = 1 (SNES time: 218 s) and np = 2 (SNES time: 600 s). PFLOTRAN final output: >> >> NP 1 >> >> FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 >> FLOW TS BE Wasted Linear Iterations = 0 >> FLOW TS BE SNES time = 218.9 seconds >> >> NP 2 >> >> FLOW TS BE steps = 67 newton = 176 linear = 314 cuts = 13 >> FLOW TS BE Wasted Linear Iterations = 208 >> FLOW TS BE SNES time = 600.0 seconds >> >> >> Robert >> >> On 06/07/17 21:24, Barry Smith wrote: >>> So on one process the outer linear solver takes a single iteration this is because the block Jacobi with LU and one block is a direct solver. >>> >>> >>>> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >>>> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 >>>> >>> On two processes the outer linear solver takes a few iterations to solver, this is to be expected. >>> >>> But what you sent doesn't give any indication about SNES not converging. Please turn off all inner linear solver monitoring and just run with -ksp_monitor_true_residual -snes_monitor -snes_lineseach_monitor -snes_converged_reason >>> >>> Barry >>> >>> >>> >>> >>>> On Jul 6, 2017, at 2:03 PM, Robert Annewandter >>>> wrote: >>>> >>>> Hi all, >>>> >>>> I like to understand why the SNES of my CPR-AMG Two-Stage Preconditioner (with KSPFGMRES + multipl. PCComposite (PCGalerkin with KSPGMRES + BoomerAMG, PCBJacobi + PCLU init) on a 24,000 x 24,000 matrix) struggles to converge when using two cores instead of one. Because of the adaptive time stepping of the Newton, this leads to severe cuts in time step. >>>> >>>> This is how I run it with two cores >>>> >>>> mpirun \ >>>> -n 2 pflotran \ >>>> -pflotranin het.pflinput \ >>>> -ksp_monitor_true_residual \ >>>> -flow_snes_view \ >>>> -flow_snes_converged_reason \ >>>> -flow_sub_1_pc_type bjacobi \ >>>> -flow_sub_1_sub_pc_type lu \ >>>> -flow_sub_1_sub_pc_factor_pivot_in_blocks true\ >>>> -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ >>>> -options_left \ >>>> -log_summary \ >>>> -info >>>> >>>> >>>> With one core I get (after grepping the crap away from -info): >>>> >>>> Step 32 Time= 1.80000E+01 >>>> >>>> [...] >>>> >>>> 0 2r: 1.58E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 7.18E-03 iu: 0.00E+00 rsn: 0 >>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>> Residual norms for flow_ solve. >>>> 0 KSP unpreconditioned resid norm 1.581814306485e-02 true resid norm 1.581814306485e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>> Residual norms for flow_sub_0_galerkin_ solve. >>>> 0 KSP preconditioned resid norm 5.697603110484e+07 true resid norm 5.175721849125e+03 ||r(i)||/||b|| 5.037527476892e+03 >>>> 1 KSP preconditioned resid norm 5.041509073319e+06 true resid norm 3.251596928176e+02 ||r(i)||/||b|| 3.164777657484e+02 >>>> 2 KSP preconditioned resid norm 1.043761838360e+06 true resid norm 8.957519558348e+01 ||r(i)||/||b|| 8.718349288342e+01 >>>> 3 KSP preconditioned resid norm 1.129189815646e+05 true resid norm 2.722436912053e+00 ||r(i)||/||b|| 2.649746479496e+00 >>>> 4 KSP preconditioned resid norm 8.829637298082e+04 true resid norm 8.026373593492e+00 ||r(i)||/||b|| 7.812065388300e+00 >>>> 5 KSP preconditioned resid norm 6.506021637694e+04 true resid norm 3.479889319880e+00 ||r(i)||/||b|| 3.386974527698e+00 >>>> 6 KSP preconditioned resid norm 6.392263200180e+04 true resid norm 3.819202631980e+00 ||r(i)||/||b|| 3.717228003987e+00 >>>> 7 KSP preconditioned resid norm 2.464946645480e+04 true resid norm 7.329964753388e-01 ||r(i)||/||b|| 7.134251013911e-01 >>>> 8 KSP preconditioned resid norm 2.603879153772e+03 true resid norm 2.035525412004e-02 ||r(i)||/||b|| 1.981175861414e-02 >>>> 9 KSP preconditioned resid norm 1.774410462754e+02 true resid norm 3.001214973121e-03 ||r(i)||/||b|| 2.921081026352e-03 >>>> 10 KSP preconditioned resid norm 1.664227038378e+01 true resid norm 3.413136309181e-04 ||r(i)||/||b|| 3.322003855903e-04 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 1.131868956745e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 2.067297386780e+07 at iteration 11 >>>> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >>>> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 >>>> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=1 >>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 3.590873180642e-01 near zero implies inconsistent rhs >>>> [0] SNESSolve_NEWTONLS(): fnorm=1.5818143064846742e-02, gnorm=1.0695649833687331e-02, ynorm=4.6826522561266171e+02, lssucceed=0 >>>> [0] SNESConvergedDefault(): Converged due to small update length: 4.682652256127e+02 < 1.000000000000e-05 * 3.702480426117e+09 >>>> 1 2r: 1.07E-02 2x: 3.70E+09 2u: 4.68E+02 ir: 5.05E-03 iu: 4.77E+01 rsn: stol >>>> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 >>>> >>>> >>>> >>>> But with two cores I get: >>>> >>>> >>>> Step 32 Time= 1.80000E+01 >>>> >>>> [...] >>>> >>>> 0 2r: 6.16E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 3.63E-03 iu: 0.00E+00 rsn: 0 >>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>> >>>> Residual norms for flow_ solve. >>>> 0 KSP unpreconditioned resid norm 6.162760088924e-03 true resid norm 6.162760088924e-03 ||r(i)||/||b|| 1.000000000000e+00 >>>> Residual norms for flow_sub_0_galerkin_ solve. >>>> 0 KSP preconditioned resid norm 8.994949630499e+08 true resid norm 7.982144380936e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>> 1 KSP preconditioned resid norm 8.950556502615e+08 true resid norm 1.550138696155e+00 ||r(i)||/||b|| 1.942007839218e+00 >>>> 2 KSP preconditioned resid norm 1.044849684205e+08 true resid norm 2.166193480531e+00 ||r(i)||/||b|| 2.713798920631e+00 >>>> 3 KSP preconditioned resid norm 8.209708619718e+06 true resid norm 3.076045005154e-01 ||r(i)||/||b|| 3.853657436340e-01 >>>> 4 KSP preconditioned resid norm 3.027461352422e+05 true resid norm 1.207731865714e-02 ||r(i)||/||b|| 1.513041869549e-02 >>>> 5 KSP preconditioned resid norm 1.595302164817e+04 true resid norm 4.123713694368e-04 ||r(i)||/||b|| 5.166172769585e-04 >>>> 6 KSP preconditioned resid norm 1.898935810797e+03 true resid norm 8.275885058330e-05 ||r(i)||/||b|| 1.036799719897e-04 >>>> 7 KSP preconditioned resid norm 1.429881682558e+02 true resid norm 4.751240525466e-06 ||r(i)||/||b|| 5.952335987324e-06 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 8.404003313455e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.994949630499e+08 at iteration 8 >>>> 8 KSP preconditioned resid norm 8.404003313455e+00 true resid norm 3.841921844578e-07 ||r(i)||/||b|| 4.813145016211e-07 >>>> 1 KSP unpreconditioned resid norm 6.162162548202e-03 true resid norm 6.162162548202e-03 ||r(i)||/||b|| 9.999030400804e-01 >>>> Residual norms for flow_sub_0_galerkin_ solve. >>>> 0 KSP preconditioned resid norm 4.360556381209e+07 true resid norm 1.000000245433e+00 ||r(i)||/||b|| 1.000000000000e+00 >>>> 1 KSP preconditioned resid norm 5.385519331932e+06 true resid norm 8.785183939860e-02 ||r(i)||/||b|| 8.785181783689e-02 >>>> 2 KSP preconditioned resid norm 4.728931283459e+05 true resid norm 2.008708805316e-02 ||r(i)||/||b|| 2.008708312313e-02 >>>> 3 KSP preconditioned resid norm 2.734215698319e+04 true resid norm 6.418720397673e-03 ||r(i)||/||b|| 6.418718822309e-03 >>>> 4 KSP preconditioned resid norm 1.002270029334e+04 true resid norm 4.040289515991e-03 ||r(i)||/||b|| 4.040288524372e-03 >>>> 5 KSP preconditioned resid norm 1.321280190971e+03 true resid norm 1.023292238313e-04 ||r(i)||/||b|| 1.023291987163e-04 >>>> 6 KSP preconditioned resid norm 6.594292964815e+01 true resid norm 1.877106733170e-06 ||r(i)||/||b|| 1.877106272467e-06 >>>> 7 KSP preconditioned resid norm 7.816325147216e+00 true resid norm 2.552611664980e-07 ||r(i)||/||b|| 2.552611038486e-07 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.391568446109e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.360556381209e+07 at iteration 8 >>>> 8 KSP preconditioned resid norm 6.391568446109e-01 true resid norm 1.680724939670e-08 ||r(i)||/||b|| 1.680724527166e-08 >>>> 2 KSP unpreconditioned resid norm 4.328902922753e-07 true resid norm 4.328902922752e-07 ||r(i)||/||b|| 7.024292460341e-05 >>>> Residual norms for flow_sub_0_galerkin_ solve. >>>> 0 KSP preconditioned resid norm 8.794597825780e+08 true resid norm 1.000000094566e+00 ||r(i)||/||b|| 1.000000000000e+00 >>>> 1 KSP preconditioned resid norm 8.609906572102e+08 true resid norm 2.965044981249e+00 ||r(i)||/||b|| 2.965044700856e+00 >>>> 2 KSP preconditioned resid norm 9.318108989314e+07 true resid norm 1.881262939380e+00 ||r(i)||/||b|| 1.881262761477e+00 >>>> 3 KSP preconditioned resid norm 6.908723262483e+06 true resid norm 2.639592490398e-01 ||r(i)||/||b|| 2.639592240782e-01 >>>> 4 KSP preconditioned resid norm 2.651677791227e+05 true resid norm 9.736480169584e-03 ||r(i)||/||b|| 9.736479248845e-03 >>>> 5 KSP preconditioned resid norm 1.192178471172e+04 true resid norm 3.082839752692e-04 ||r(i)||/||b|| 3.082839461160e-04 >>>> 6 KSP preconditioned resid norm 1.492201446262e+03 true resid norm 4.633866284506e-05 ||r(i)||/||b|| 4.633865846301e-05 >>>> 7 KSP preconditioned resid norm 1.160670017241e+02 true resid norm 2.821157348522e-06 ||r(i)||/||b|| 2.821157081737e-06 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.447568262216e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.794597825780e+08 at iteration 8 >>>> 8 KSP preconditioned resid norm 6.447568262216e+00 true resid norm 1.516068561348e-07 ||r(i)||/||b|| 1.516068417980e-07 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.135731709822e-15 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.162760088924e-03 at iteration 3 >>>> 3 KSP unpreconditioned resid norm 6.135731709822e-15 true resid norm 1.142020328809e-14 ||r(i)||/||b|| 1.853098793933e-12 >>>> >>>> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=3 >>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 1.998388224666e-02 near zero implies inconsistent rhs >>>> [0] SNESSolve_NEWTONLS(): fnorm=6.1627600889243711e-03, gnorm=1.0406503258190572e-02, ynorm=6.2999025681245366e+04, lssucceed=0 >>>> 1 2r: 1.04E-02 2x: 3.70E+09 2u: 6.30E+04 ir: 6.54E-03 iu: 5.00E+04 rsn: 0 >>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>> >>>> Residual norms for flow_ solve. >>>> 0 KSP unpreconditioned resid norm 1.040650325819e-02 true resid norm 1.040650325819e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>> Residual norms for flow_sub_0_galerkin_ solve. >>>> 0 KSP preconditioned resid norm 6.758906811264e+07 true resid norm 9.814998431686e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>> 1 KSP preconditioned resid norm 2.503922806424e+06 true resid norm 2.275130113021e-01 ||r(i)||/||b|| 2.318013730574e-01 >>>> 2 KSP preconditioned resid norm 3.316753614870e+05 true resid norm 3.820733530238e-02 ||r(i)||/||b|| 3.892750016040e-02 >>>> 3 KSP preconditioned resid norm 2.956751700483e+04 true resid norm 2.143772538677e-03 ||r(i)||/||b|| 2.184180215207e-03 >>>> 4 KSP preconditioned resid norm 1.277067042524e+03 true resid norm 9.093614251311e-05 ||r(i)||/||b|| 9.265018547485e-05 >>>> 5 KSP preconditioned resid norm 1.060996002446e+02 true resid norm 1.042893700050e-05 ||r(i)||/||b|| 1.062551061326e-05 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 5.058127343285e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.758906811264e+07 at iteration 6 >>>> 6 KSP preconditioned resid norm 5.058127343285e+00 true resid norm 4.054770602120e-07 ||r(i)||/||b|| 4.131198420807e-07 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.449606189225e-10 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.040650325819e-02 at iteration 1 >>>> 1 KSP unpreconditioned resid norm 4.449606189225e-10 true resid norm 4.449606189353e-10 ||r(i)||/||b|| 4.275793779098e-08 >>>> >>>> [0] SNESSolve_NEWTONLS(): iter=1, linear solve iterations=1 >>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.300066663571e-02 near zero implies inconsistent rhs >>>> [0] SNESSolve_NEWTONLS(): fnorm=1.0406503258190572e-02, gnorm=7.3566280848133728e-02, ynorm=7.9500485128639993e+04, lssucceed=0 >>>> 2 2r: 7.36E-02 2x: 3.70E+09 2u: 7.95E+04 ir: 4.62E-02 iu: 5.00E+04 rsn: 0 >>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>> >>>> Residual norms for flow_ solve. >>>> 0 KSP unpreconditioned resid norm 7.356628084813e-02 true resid norm 7.356628084813e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>> Residual norms for flow_sub_0_galerkin_ solve. >>>> 0 KSP preconditioned resid norm 7.253424029194e+06 true resid norm 9.647008645250e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>> 1 KSP preconditioned resid norm 7.126940190688e+06 true resid norm 1.228009197928e+00 ||r(i)||/||b|| 1.272942984800e+00 >>>> 2 KSP preconditioned resid norm 9.391591432635e+05 true resid norm 7.804929162756e-01 ||r(i)||/||b|| 8.090517433711e-01 >>>> 3 KSP preconditioned resid norm 6.538499674761e+04 true resid norm 5.503467432893e-02 ||r(i)||/||b|| 5.704843475602e-02 >>>> 4 KSP preconditioned resid norm 1.593713396575e+04 true resid norm 8.902701363763e-02 ||r(i)||/||b|| 9.228457951208e-02 >>>> 5 KSP preconditioned resid norm 4.837260621464e+02 true resid norm 2.966772992825e-03 ||r(i)||/||b|| 3.075329464213e-03 >>>> 6 KSP preconditioned resid norm 1.681372767335e+02 true resid norm 5.312467443025e-04 ||r(i)||/||b|| 5.506854651406e-04 >>>> 7 KSP preconditioned resid norm 1.271478850717e+01 true resid norm 2.123810020488e-05 ||r(i)||/||b|| 2.201521838103e-05 >>>> 8 KSP preconditioned resid norm 1.262723712696e+00 true resid norm 1.150572715331e-06 ||r(i)||/||b|| 1.192673042641e-06 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 9.053072585125e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.253424029194e+06 at iteration 9 >>>> 9 KSP preconditioned resid norm 9.053072585125e-02 true resid norm 9.475050575058e-08 ||r(i)||/||b|| 9.821749853747e-08 >>>> 1 KSP unpreconditioned resid norm 8.171589173162e-03 true resid norm 8.171589173162e-03 ||r(i)||/||b|| 1.110779161180e-01 >>>> Residual norms for flow_sub_0_galerkin_ solve. >>>> 0 KSP preconditioned resid norm 4.345765068989e+07 true resid norm 9.999992231691e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>> 1 KSP preconditioned resid norm 5.388715093466e+06 true resid norm 8.125387327699e-02 ||r(i)||/||b|| 8.125393639755e-02 >>>> 2 KSP preconditioned resid norm 4.763725726436e+05 true resid norm 2.464285618036e-02 ||r(i)||/||b|| 2.464287532371e-02 >>>> 3 KSP preconditioned resid norm 2.287746683380e+04 true resid norm 7.224823080100e-03 ||r(i)||/||b|| 7.224828692570e-03 >>>> 4 KSP preconditioned resid norm 4.872858764091e+03 true resid norm 3.972261388893e-03 ||r(i)||/||b|| 3.972264474670e-03 >>>> 5 KSP preconditioned resid norm 8.670449895323e+02 true resid norm 2.359005963873e-04 ||r(i)||/||b|| 2.359007796423e-04 >>>> 6 KSP preconditioned resid norm 4.252589693890e+01 true resid norm 1.471904261226e-06 ||r(i)||/||b|| 1.471905404648e-06 >>>> 7 KSP preconditioned resid norm 5.128476471782e+00 true resid norm 1.643725157865e-07 ||r(i)||/||b|| 1.643726434763e-07 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.311901915856e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.345765068989e+07 at iteration 8 >>>> 8 KSP preconditioned resid norm 4.311901915856e-01 true resid norm 1.166123921637e-08 ||r(i)||/||b|| 1.166124827519e-08 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.373662391739e-09 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.356628084813e-02 at iteration 2 >>>> 2 KSP unpreconditioned resid norm 2.373662391739e-09 true resid norm 2.373662391658e-09 ||r(i)||/||b|| 3.226562990941e-08 >>>> >>>> [0] SNESSolve_NEWTONLS(): iter=2, linear solve iterations=2 >>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.343326231305e-02 near zero implies inconsistent rhs >>>> [0] SNESSolve_NEWTONLS(): fnorm=7.3566280848133728e-02, gnorm=7.2259942496422647e-02, ynorm=6.3156901950486099e+04, lssucceed=0 >>>> 3 2r: 7.23E-02 2x: 3.70E+09 2u: 6.32E+04 ir: 4.52E-02 iu: 5.00E+04 rsn: 0 >>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>> >>>> Residual norms for flow_ solve. >>>> 0 KSP unpreconditioned resid norm 7.225994249642e-02 true resid norm 7.225994249642e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>> Residual norms for flow_sub_0_galerkin_ solve. >>>> 0 KSP preconditioned resid norm 7.705582590638e+05 true resid norm 9.649751442741e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>> 1 KSP preconditioned resid norm 2.444424220392e+04 true resid norm 8.243110200738e-03 ||r(i)||/||b|| 8.542303135630e-03 >>>> 2 KSP preconditioned resid norm 2.080899648412e+03 true resid norm 7.642343147053e-04 ||r(i)||/||b|| 7.919730567570e-04 >>>> 3 KSP preconditioned resid norm 9.911171129874e+02 true resid norm 5.904182179180e-05 ||r(i)||/||b|| 6.118481096859e-05 >>>> 4 KSP preconditioned resid norm 5.258230282482e+02 true resid norm 2.043366677644e-04 ||r(i)||/||b|| 2.117532964210e-04 >>>> 5 KSP preconditioned resid norm 5.522830460456e+01 true resid norm 1.710780366056e-05 ||r(i)||/||b|| 1.772875059225e-05 >>>> 6 KSP preconditioned resid norm 5.922280741715e+00 true resid norm 1.543198740828e-06 ||r(i)||/||b|| 1.599210870855e-06 >>>> 7 KSP preconditioned resid norm 3.339500859115e-01 true resid norm 1.221335666427e-07 ||r(i)||/||b|| 1.265665414984e-07 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 3.329208597672e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.705582590638e+05 at iteration 8 >>>> 8 KSP preconditioned resid norm 3.329208597672e-02 true resid norm 9.758240835324e-09 ||r(i)||/||b|| 1.011242713683e-08 >>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.697128456432e-11 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.225994249642e-02 at iteration 1 >>>> 1 KSP unpreconditioned resid norm 2.697128456432e-11 true resid norm 2.697128457142e-11 ||r(i)||/||b|| 3.732536124389e-10 >>>> >>>> [0] SNESSolve_NEWTONLS(): iter=3, linear solve iterations=1 >>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.329227684222e-02 near zero implies inconsistent rhs >>>> [0] SNESSolve_NEWTONLS(): fnorm=7.2259942496422647e-02, gnorm=5.4435602192925014e-01, ynorm=2.7049750229137400e+04, lssucceed=0 >>>> [0] SNESConvergedDefault(): Converged due to small update length: 2.704975022914e+04 < 1.000000000000e-05 * 3.702469482296e+09 >>>> 4 2r: 5.44E-01 2x: 3.70E+09 2u: 2.70E+04 ir: 3.84E-01 iu: 2.34E+04 rsn: stol >>>> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 4 >>>> >>>> >>>> As the simulation advances this behaviour leads to frequent time step cuts because of 8 subsequently failed Newton iterations, which brings the simulation practically to a halt. >>>> >>>> Is the Block Jacobi not a good choice? Better ASM with huge overlap? Or is there something wrong with my RHS? Maybe the SNES, SNESLS, KSP tolerances need better tuning? >>>> >>>> Grateful for any clarifying words! >>>> Robert >>>> >>>> >>>> My SNES_view is: >>>> >>>> >>>> SNES Object: (flow_) 2 MPI processes >>>> type: newtonls >>>> maximum iterations=8, maximum function evaluations=10000 >>>> tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 >>>> total number of linear solver iterations=1 >>>> total number of function evaluations=2 >>>> norm schedule ALWAYS >>>> SNESLineSearch Object: (flow_) 2 MPI processes >>>> type: basic >>>> maxstep=1.000000e+08, minlambda=1.000000e-05 >>>> tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 >>>> maximum iterations=40 >>>> using user-defined precheck step >>>> KSP Object: (flow_) 2 MPI processes >>>> type: fgmres >>>> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >>>> GMRES: happy breakdown tolerance 1e-30 >>>> maximum iterations=200, initial guess is zero >>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>> right preconditioning >>>> using UNPRECONDITIONED norm type for convergence test >>>> PC Object: (flow_) 2 MPI processes >>>> type: composite >>>> Composite PC type - MULTIPLICATIVE >>>> PCs on composite preconditioner follow >>>> --------------------------------- >>>> PC Object: (flow_sub_0_) 2 MPI processes >>>> type: galerkin >>>> Galerkin PC >>>> KSP on Galerkin follow >>>> --------------------------------- >>>> KSP Object: (flow_sub_0_galerkin_) 2 MPI processes >>>> type: gmres >>>> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >>>> GMRES: happy breakdown tolerance 1e-30 >>>> maximum iterations=200, initial guess is zero >>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>> left preconditioning >>>> using PRECONDITIONED norm type for convergence test >>>> PC Object: (flow_sub_0_galerkin_) 2 MPI processes >>>> type: hypre >>>> HYPRE BoomerAMG preconditioning >>>> HYPRE BoomerAMG: Cycle type V >>>> HYPRE BoomerAMG: Maximum number of levels 25 >>>> HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 >>>> HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. >>>> HYPRE BoomerAMG: Threshold for strong coupling 0.25 >>>> HYPRE BoomerAMG: Interpolation truncation factor 0. >>>> HYPRE BoomerAMG: Interpolation: max elements per row 0 >>>> HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 >>>> HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 >>>> HYPRE BoomerAMG: Maximum row sums 0.9 >>>> HYPRE BoomerAMG: Sweeps down 1 >>>> HYPRE BoomerAMG: Sweeps up 1 >>>> HYPRE BoomerAMG: Sweeps on coarse 1 >>>> HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi >>>> HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi >>>> HYPRE BoomerAMG: Relax on coarse Gaussian-elimination >>>> HYPRE BoomerAMG: Relax weight (all) 1. >>>> HYPRE BoomerAMG: Outer relax weight (all) 1. >>>> HYPRE BoomerAMG: Using CF-relaxation >>>> HYPRE BoomerAMG: Not using more complex smoothers. >>>> HYPRE BoomerAMG: Measure type local >>>> HYPRE BoomerAMG: Coarsen type Falgout >>>> HYPRE BoomerAMG: Interpolation type classical >>>> linear system matrix = precond matrix: >>>> Mat Object: 2 MPI processes >>>> type: mpiaij >>>> rows=8000, cols=8000 >>>> total: nonzeros=53600, allocated nonzeros=53600 >>>> total number of mallocs used during MatSetValues calls =0 >>>> not using I-node (on process 0) routines >>>> linear system matrix = precond matrix: >>>> Mat Object: (flow_) 2 MPI processes >>>> type: mpibaij >>>> rows=24000, cols=24000, bs=3 >>>> total: nonzeros=482400, allocated nonzeros=482400 >>>> total number of mallocs used during MatSetValues calls =0 >>>> PC Object: (flow_sub_1_) 2 MPI processes >>>> type: bjacobi >>>> block Jacobi: number of blocks = 2 >>>> Local solve is same for all blocks, in the following KSP and PC objects: >>>> KSP Object: (flow_sub_1_sub_) 1 MPI processes >>>> type: preonly >>>> maximum iterations=10000, initial guess is zero >>>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. <------ not working: -flow_sub_1_sub_ksp_rtol 1e-7 >>>> left preconditioning >>>> using NONE norm type for convergence test >>>> PC Object: (flow_sub_1_sub_) 1 MPI processes >>>> type: lu >>>> out-of-place factorization >>>> tolerance for zero pivot 2.22045e-14 >>>> matrix ordering: nd >>>> factor fill ratio given 5., needed 18.3108 >>>> Factored matrix follows: >>>> Mat Object: 1 MPI processes >>>> type: seqbaij >>>> rows=12000, cols=12000, bs=3 >>>> package used to perform factorization: petsc >>>> total: nonzeros=4350654, allocated nonzeros=4350654 >>>> total number of mallocs used during MatSetValues calls =0 >>>> block size is 3 >>>> linear system matrix = precond matrix: >>>> Mat Object: (flow_) 1 MPI processes >>>> type: seqbaij >>>> rows=12000, cols=12000, bs=3 >>>> total: nonzeros=237600, allocated nonzeros=237600 >>>> total number of mallocs used during MatSetValues calls =0 >>>> block size is 3 >>>> linear system matrix = precond matrix: >>>> Mat Object: (flow_) 2 MPI processes >>>> type: mpibaij >>>> rows=24000, cols=24000, bs=3 >>>> total: nonzeros=482400, allocated nonzeros=482400 >>>> total number of mallocs used during MatSetValues calls =0 >>>> --------------------------------- >>>> linear system matrix = precond matrix: >>>> Mat Object: (flow_) 2 MPI processes >>>> type: mpibaij >>>> rows=24000, cols=24000, bs=3 >>>> total: nonzeros=482400, allocated nonzeros=482400 >>>> total number of mallocs used during MatSetValues calls =0 >>>> >> -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: het_np_1_CPR-AMG.log Type: text/x-log Size: 53439 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: het_np_2_CPR-AMG.log Type: text/x-log Size: 144965 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: het_np_1_PCLU.log Type: text/x-log Size: 37801 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: het_np_1 PCBJACOBI_SUBPCLU.log Type: text/x-log Size: 37801 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: het_np_2_PCBJACOBI_SUBPCLU.log Type: text/x-log Size: 38231 bytes Desc: not available URL: -------------- next part -------------- -------------------------------------------------------------------------------- NP 1 KSPPREONLY PCILU -------------------------------------------------------------------------------- SNES Object: (flow_) 1 MPI processes type: newtonls maximum iterations=8, maximum function evaluations=10000 tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 total number of linear solver iterations=1 total number of function evaluations=2 norm schedule ALWAYS SNESLineSearch Object: (flow_) 1 MPI processes type: basic maxstep=1.000000e+08, minlambda=1.000000e-05 tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 maximum iterations=40 using user-defined precheck step KSP Object: (flow_) 1 MPI processes type: preonly maximum iterations=200, initial guess is zero tolerances: relative=1e-07, absolute=1e-50, divergence=10000. left preconditioning using NONE norm type for convergence test PC Object: (flow_) 1 MPI processes type: lu out-of-place factorization tolerance for zero pivot 2.22045e-14 matrix ordering: nd factor fill ratio given 5., needed 23.8274 Factored matrix follows: Mat Object: 1 MPI processes type: seqbaij rows=24000, cols=24000, bs=3 package used to perform factorization: petsc total: nonzeros=11494314, allocated nonzeros=11494314 total number of mallocs used during MatSetValues calls =0 block size is 3 linear system matrix = precond matrix: Mat Object: (flow_) 1 MPI processes type: seqbaij rows=24000, cols=24000, bs=3 total: nonzeros=482400, allocated nonzeros=482400 total number of mallocs used during MatSetValues calls =0 block size is 3 -------------------------------------------------------------------------------- NP 1 KSPREONLY PCBJACOBI SUBPCLU -------------------------------------------------------------------------------- SNES Object: (flow_) 1 MPI processes type: newtonls maximum iterations=8, maximum function evaluations=10000 tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 total number of linear solver iterations=1 total number of function evaluations=2 norm schedule ALWAYS SNESLineSearch Object: (flow_) 1 MPI processes type: basic maxstep=1.000000e+08, minlambda=1.000000e-05 tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 maximum iterations=40 using user-defined precheck step KSP Object: (flow_) 1 MPI processes type: preonly maximum iterations=200, initial guess is zero tolerances: relative=1e-07, absolute=1e-50, divergence=10000. left preconditioning using NONE norm type for convergence test PC Object: (flow_) 1 MPI processes type: bjacobi block Jacobi: number of blocks = 1 Local solve is same for all blocks, in the following KSP and PC objects: KSP Object: (flow_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: (flow_sub_) 1 MPI processes type: lu out-of-place factorization tolerance for zero pivot 2.22045e-14 matrix ordering: nd factor fill ratio given 5., needed 23.8274 Factored matrix follows: Mat Object: 1 MPI processes type: seqbaij rows=24000, cols=24000, bs=3 package used to perform factorization: petsc total: nonzeros=11494314, allocated nonzeros=11494314 total number of mallocs used during MatSetValues calls =0 block size is 3 linear system matrix = precond matrix: Mat Object: (flow_) 1 MPI processes type: seqbaij rows=24000, cols=24000, bs=3 total: nonzeros=482400, allocated nonzeros=482400 total number of mallocs used during MatSetValues calls =0 block size is 3 linear system matrix = precond matrix: Mat Object: (flow_) 1 MPI processes type: seqbaij rows=24000, cols=24000, bs=3 total: nonzeros=482400, allocated nonzeros=482400 total number of mallocs used during MatSetValues calls =0 block size is 3 -------------------------------------------------------------------------------- NP 2 KSPREONLY PCBJACOBI SUBPCLU -------------------------------------------------------------------------------- SNES Object: (flow_) 2 MPI processes type: newtonls maximum iterations=8, maximum function evaluations=10000 tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 total number of linear solver iterations=1 total number of function evaluations=2 norm schedule ALWAYS SNESLineSearch Object: (flow_) 2 MPI processes type: basic maxstep=1.000000e+08, minlambda=1.000000e-05 tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 maximum iterations=40 using user-defined precheck step KSP Object: (flow_) 2 MPI processes type: preonly maximum iterations=200, initial guess is zero tolerances: relative=1e-07, absolute=1e-50, divergence=10000. left preconditioning using NONE norm type for convergence test PC Object: (flow_) 2 MPI processes type: bjacobi block Jacobi: number of blocks = 2 Local solve is same for all blocks, in the following KSP and PC objects: KSP Object: (flow_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: (flow_sub_) 1 MPI processes type: lu out-of-place factorization tolerance for zero pivot 2.22045e-14 matrix ordering: nd factor fill ratio given 5., needed 18.3108 Factored matrix follows: Mat Object: 1 MPI processes type: seqbaij rows=12000, cols=12000, bs=3 package used to perform factorization: petsc total: nonzeros=4350654, allocated nonzeros=4350654 total number of mallocs used during MatSetValues calls =0 block size is 3 linear system matrix = precond matrix: Mat Object: (flow_) 1 MPI processes type: seqbaij rows=12000, cols=12000, bs=3 total: nonzeros=237600, allocated nonzeros=237600 total number of mallocs used during MatSetValues calls =0 block size is 3 linear system matrix = precond matrix: Mat Object: (flow_) 2 MPI processes type: mpibaij rows=24000, cols=24000, bs=3 total: nonzeros=482400, allocated nonzeros=482400 total number of mallocs used during MatSetValues calls =0 From hong at aspiritech.org Fri Jul 7 09:49:32 2017 From: hong at aspiritech.org (hong at aspiritech.org) Date: Fri, 7 Jul 2017 09:49:32 -0500 Subject: [petsc-users] CPR-AMG: SNES with two cores worse than with one In-Reply-To: <981f495d-529c-88be-bdaa-4db736e7f357@opengosim.com> References: <293da4be-1eaa-9ac0-54fe-171832a5b4af@opengosim.com> <981f495d-529c-88be-bdaa-4db736e7f357@opengosim.com> Message-ID: What do you get with '-ksp_type gmres' or '-ksp_type bcgs' in parallel runs? Hong On Fri, Jul 7, 2017 at 6:05 AM, Robert Annewandter < robert.annewandter at opengosim.com> wrote: > Yes indeed, PFLOTRAN cuts timestep after 8 failed iterations of SNES. > > I've rerun with -snes_monitor (attached with canonical suffix), their > -pc_type is always PCBJACOBI + PCLU (though we'd like to try SUPERLU in the > future, however it works only with -mat_type aij..) > > > The sequential and parallel runs I did with > > -ksp_type preonly -pc_type lu -pc_factor_nonzeros_along_diagonal > -snes_monitor > > and > > -ksp_type preonly -pc_type bjacobi -sub_pc_type lu > -sub_pc_factor_nonzeros_along_diagonal -snes_monitor > > As expected, the sequential are bot identical and the parallel takes half > the time compared to sequential. > > > > > On 07/07/17 01:20, Barry Smith wrote: > > Looks like PFLOTRAN has a maximum number of SNES iterations as 8 and cuts the timestep if that fails. > > Please run with -snes_monitor I don't understand the strange densely packed information that PFLOTRAN is printing. > > It looks like the linear solver is converging fine in parallel, normally then there is absolutely no reason that the Newton should behave different on 2 processors than 1 unless there is something wrong with the Jacobian. What is the -pc_type for the two cases LU or your fancy thing? > > Please run sequential and parallel with -pc_type lu and also with -snes_monitor. We need to fix all the knobs but one in order to understand what is going on. > > > Barry > > > > > On Jul 6, 2017, at 5:11 PM, Robert Annewandter wrote: > > Thanks Barry! > > I've attached log files for np = 1 (SNES time: 218 s) and np = 2 (SNES time: 600 s). PFLOTRAN final output: > > NP 1 > > FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 > FLOW TS BE Wasted Linear Iterations = 0 > FLOW TS BE SNES time = 218.9 seconds > > NP 2 > > FLOW TS BE steps = 67 newton = 176 linear = 314 cuts = 13 > FLOW TS BE Wasted Linear Iterations = 208 > FLOW TS BE SNES time = 600.0 seconds > > > Robert > > On 06/07/17 21:24, Barry Smith wrote: > > So on one process the outer linear solver takes a single iteration this is because the block Jacobi with LU and one block is a direct solver. > > > > 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 > 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 > > > On two processes the outer linear solver takes a few iterations to solver, this is to be expected. > > But what you sent doesn't give any indication about SNES not converging. Please turn off all inner linear solver monitoring and just run with -ksp_monitor_true_residual -snes_monitor -snes_lineseach_monitor -snes_converged_reason > > Barry > > > > > > On Jul 6, 2017, at 2:03 PM, Robert Annewandter > wrote: > > Hi all, > > I like to understand why the SNES of my CPR-AMG Two-Stage Preconditioner (with KSPFGMRES + multipl. PCComposite (PCGalerkin with KSPGMRES + BoomerAMG, PCBJacobi + PCLU init) on a 24,000 x 24,000 matrix) struggles to converge when using two cores instead of one. Because of the adaptive time stepping of the Newton, this leads to severe cuts in time step. > > This is how I run it with two cores > > mpirun \ > -n 2 pflotran \ > -pflotranin het.pflinput \ > -ksp_monitor_true_residual \ > -flow_snes_view \ > -flow_snes_converged_reason \ > -flow_sub_1_pc_type bjacobi \ > -flow_sub_1_sub_pc_type lu \ > -flow_sub_1_sub_pc_factor_pivot_in_blocks true\ > -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ > -options_left \ > -log_summary \ > -info > > > With one core I get (after grepping the crap away from -info): > > Step 32 Time= 1.80000E+01 > > [...] > > 0 2r: 1.58E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 7.18E-03 iu: 0.00E+00 rsn: 0 > [0] SNESComputeJacobian(): Rebuilding preconditioner > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 1.581814306485e-02 true resid norm 1.581814306485e-02 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 5.697603110484e+07 true resid norm 5.175721849125e+03 ||r(i)||/||b|| 5.037527476892e+03 > 1 KSP preconditioned resid norm 5.041509073319e+06 true resid norm 3.251596928176e+02 ||r(i)||/||b|| 3.164777657484e+02 > 2 KSP preconditioned resid norm 1.043761838360e+06 true resid norm 8.957519558348e+01 ||r(i)||/||b|| 8.718349288342e+01 > 3 KSP preconditioned resid norm 1.129189815646e+05 true resid norm 2.722436912053e+00 ||r(i)||/||b|| 2.649746479496e+00 > 4 KSP preconditioned resid norm 8.829637298082e+04 true resid norm 8.026373593492e+00 ||r(i)||/||b|| 7.812065388300e+00 > 5 KSP preconditioned resid norm 6.506021637694e+04 true resid norm 3.479889319880e+00 ||r(i)||/||b|| 3.386974527698e+00 > 6 KSP preconditioned resid norm 6.392263200180e+04 true resid norm 3.819202631980e+00 ||r(i)||/||b|| 3.717228003987e+00 > 7 KSP preconditioned resid norm 2.464946645480e+04 true resid norm 7.329964753388e-01 ||r(i)||/||b|| 7.134251013911e-01 > 8 KSP preconditioned resid norm 2.603879153772e+03 true resid norm 2.035525412004e-02 ||r(i)||/||b|| 1.981175861414e-02 > 9 KSP preconditioned resid norm 1.774410462754e+02 true resid norm 3.001214973121e-03 ||r(i)||/||b|| 2.921081026352e-03 > 10 KSP preconditioned resid norm 1.664227038378e+01 true resid norm 3.413136309181e-04 ||r(i)||/||b|| 3.322003855903e-04 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 1.131868956745e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 2.067297386780e+07 at iteration 11 > 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 > 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 > [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=1 > [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 3.590873180642e-01 near zero implies inconsistent rhs > [0] SNESSolve_NEWTONLS(): fnorm=1.5818143064846742e-02, gnorm=1.0695649833687331e-02, ynorm=4.6826522561266171e+02, lssucceed=0 > [0] SNESConvergedDefault(): Converged due to small update length: 4.682652256127e+02 < 1.000000000000e-05 * 3.702480426117e+09 > 1 2r: 1.07E-02 2x: 3.70E+09 2u: 4.68E+02 ir: 5.05E-03 iu: 4.77E+01 rsn: stol > Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 > > > > But with two cores I get: > > > Step 32 Time= 1.80000E+01 > > [...] > > 0 2r: 6.16E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 3.63E-03 iu: 0.00E+00 rsn: 0 > [0] SNESComputeJacobian(): Rebuilding preconditioner > > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 6.162760088924e-03 true resid norm 6.162760088924e-03 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 8.994949630499e+08 true resid norm 7.982144380936e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 8.950556502615e+08 true resid norm 1.550138696155e+00 ||r(i)||/||b|| 1.942007839218e+00 > 2 KSP preconditioned resid norm 1.044849684205e+08 true resid norm 2.166193480531e+00 ||r(i)||/||b|| 2.713798920631e+00 > 3 KSP preconditioned resid norm 8.209708619718e+06 true resid norm 3.076045005154e-01 ||r(i)||/||b|| 3.853657436340e-01 > 4 KSP preconditioned resid norm 3.027461352422e+05 true resid norm 1.207731865714e-02 ||r(i)||/||b|| 1.513041869549e-02 > 5 KSP preconditioned resid norm 1.595302164817e+04 true resid norm 4.123713694368e-04 ||r(i)||/||b|| 5.166172769585e-04 > 6 KSP preconditioned resid norm 1.898935810797e+03 true resid norm 8.275885058330e-05 ||r(i)||/||b|| 1.036799719897e-04 > 7 KSP preconditioned resid norm 1.429881682558e+02 true resid norm 4.751240525466e-06 ||r(i)||/||b|| 5.952335987324e-06 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 8.404003313455e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.994949630499e+08 at iteration 8 > 8 KSP preconditioned resid norm 8.404003313455e+00 true resid norm 3.841921844578e-07 ||r(i)||/||b|| 4.813145016211e-07 > 1 KSP unpreconditioned resid norm 6.162162548202e-03 true resid norm 6.162162548202e-03 ||r(i)||/||b|| 9.999030400804e-01 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 4.360556381209e+07 true resid norm 1.000000245433e+00 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.385519331932e+06 true resid norm 8.785183939860e-02 ||r(i)||/||b|| 8.785181783689e-02 > 2 KSP preconditioned resid norm 4.728931283459e+05 true resid norm 2.008708805316e-02 ||r(i)||/||b|| 2.008708312313e-02 > 3 KSP preconditioned resid norm 2.734215698319e+04 true resid norm 6.418720397673e-03 ||r(i)||/||b|| 6.418718822309e-03 > 4 KSP preconditioned resid norm 1.002270029334e+04 true resid norm 4.040289515991e-03 ||r(i)||/||b|| 4.040288524372e-03 > 5 KSP preconditioned resid norm 1.321280190971e+03 true resid norm 1.023292238313e-04 ||r(i)||/||b|| 1.023291987163e-04 > 6 KSP preconditioned resid norm 6.594292964815e+01 true resid norm 1.877106733170e-06 ||r(i)||/||b|| 1.877106272467e-06 > 7 KSP preconditioned resid norm 7.816325147216e+00 true resid norm 2.552611664980e-07 ||r(i)||/||b|| 2.552611038486e-07 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.391568446109e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.360556381209e+07 at iteration 8 > 8 KSP preconditioned resid norm 6.391568446109e-01 true resid norm 1.680724939670e-08 ||r(i)||/||b|| 1.680724527166e-08 > 2 KSP unpreconditioned resid norm 4.328902922753e-07 true resid norm 4.328902922752e-07 ||r(i)||/||b|| 7.024292460341e-05 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 8.794597825780e+08 true resid norm 1.000000094566e+00 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 8.609906572102e+08 true resid norm 2.965044981249e+00 ||r(i)||/||b|| 2.965044700856e+00 > 2 KSP preconditioned resid norm 9.318108989314e+07 true resid norm 1.881262939380e+00 ||r(i)||/||b|| 1.881262761477e+00 > 3 KSP preconditioned resid norm 6.908723262483e+06 true resid norm 2.639592490398e-01 ||r(i)||/||b|| 2.639592240782e-01 > 4 KSP preconditioned resid norm 2.651677791227e+05 true resid norm 9.736480169584e-03 ||r(i)||/||b|| 9.736479248845e-03 > 5 KSP preconditioned resid norm 1.192178471172e+04 true resid norm 3.082839752692e-04 ||r(i)||/||b|| 3.082839461160e-04 > 6 KSP preconditioned resid norm 1.492201446262e+03 true resid norm 4.633866284506e-05 ||r(i)||/||b|| 4.633865846301e-05 > 7 KSP preconditioned resid norm 1.160670017241e+02 true resid norm 2.821157348522e-06 ||r(i)||/||b|| 2.821157081737e-06 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.447568262216e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.794597825780e+08 at iteration 8 > 8 KSP preconditioned resid norm 6.447568262216e+00 true resid norm 1.516068561348e-07 ||r(i)||/||b|| 1.516068417980e-07 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.135731709822e-15 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.162760088924e-03 at iteration 3 > 3 KSP unpreconditioned resid norm 6.135731709822e-15 true resid norm 1.142020328809e-14 ||r(i)||/||b|| 1.853098793933e-12 > > [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=3 > [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 1.998388224666e-02 near zero implies inconsistent rhs > [0] SNESSolve_NEWTONLS(): fnorm=6.1627600889243711e-03, gnorm=1.0406503258190572e-02, ynorm=6.2999025681245366e+04, lssucceed=0 > 1 2r: 1.04E-02 2x: 3.70E+09 2u: 6.30E+04 ir: 6.54E-03 iu: 5.00E+04 rsn: 0 > [0] SNESComputeJacobian(): Rebuilding preconditioner > > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 1.040650325819e-02 true resid norm 1.040650325819e-02 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 6.758906811264e+07 true resid norm 9.814998431686e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.503922806424e+06 true resid norm 2.275130113021e-01 ||r(i)||/||b|| 2.318013730574e-01 > 2 KSP preconditioned resid norm 3.316753614870e+05 true resid norm 3.820733530238e-02 ||r(i)||/||b|| 3.892750016040e-02 > 3 KSP preconditioned resid norm 2.956751700483e+04 true resid norm 2.143772538677e-03 ||r(i)||/||b|| 2.184180215207e-03 > 4 KSP preconditioned resid norm 1.277067042524e+03 true resid norm 9.093614251311e-05 ||r(i)||/||b|| 9.265018547485e-05 > 5 KSP preconditioned resid norm 1.060996002446e+02 true resid norm 1.042893700050e-05 ||r(i)||/||b|| 1.062551061326e-05 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 5.058127343285e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.758906811264e+07 at iteration 6 > 6 KSP preconditioned resid norm 5.058127343285e+00 true resid norm 4.054770602120e-07 ||r(i)||/||b|| 4.131198420807e-07 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.449606189225e-10 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.040650325819e-02 at iteration 1 > 1 KSP unpreconditioned resid norm 4.449606189225e-10 true resid norm 4.449606189353e-10 ||r(i)||/||b|| 4.275793779098e-08 > > [0] SNESSolve_NEWTONLS(): iter=1, linear solve iterations=1 > [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.300066663571e-02 near zero implies inconsistent rhs > [0] SNESSolve_NEWTONLS(): fnorm=1.0406503258190572e-02, gnorm=7.3566280848133728e-02, ynorm=7.9500485128639993e+04, lssucceed=0 > 2 2r: 7.36E-02 2x: 3.70E+09 2u: 7.95E+04 ir: 4.62E-02 iu: 5.00E+04 rsn: 0 > [0] SNESComputeJacobian(): Rebuilding preconditioner > > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 7.356628084813e-02 true resid norm 7.356628084813e-02 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 7.253424029194e+06 true resid norm 9.647008645250e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 7.126940190688e+06 true resid norm 1.228009197928e+00 ||r(i)||/||b|| 1.272942984800e+00 > 2 KSP preconditioned resid norm 9.391591432635e+05 true resid norm 7.804929162756e-01 ||r(i)||/||b|| 8.090517433711e-01 > 3 KSP preconditioned resid norm 6.538499674761e+04 true resid norm 5.503467432893e-02 ||r(i)||/||b|| 5.704843475602e-02 > 4 KSP preconditioned resid norm 1.593713396575e+04 true resid norm 8.902701363763e-02 ||r(i)||/||b|| 9.228457951208e-02 > 5 KSP preconditioned resid norm 4.837260621464e+02 true resid norm 2.966772992825e-03 ||r(i)||/||b|| 3.075329464213e-03 > 6 KSP preconditioned resid norm 1.681372767335e+02 true resid norm 5.312467443025e-04 ||r(i)||/||b|| 5.506854651406e-04 > 7 KSP preconditioned resid norm 1.271478850717e+01 true resid norm 2.123810020488e-05 ||r(i)||/||b|| 2.201521838103e-05 > 8 KSP preconditioned resid norm 1.262723712696e+00 true resid norm 1.150572715331e-06 ||r(i)||/||b|| 1.192673042641e-06 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 9.053072585125e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.253424029194e+06 at iteration 9 > 9 KSP preconditioned resid norm 9.053072585125e-02 true resid norm 9.475050575058e-08 ||r(i)||/||b|| 9.821749853747e-08 > 1 KSP unpreconditioned resid norm 8.171589173162e-03 true resid norm 8.171589173162e-03 ||r(i)||/||b|| 1.110779161180e-01 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 4.345765068989e+07 true resid norm 9.999992231691e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 5.388715093466e+06 true resid norm 8.125387327699e-02 ||r(i)||/||b|| 8.125393639755e-02 > 2 KSP preconditioned resid norm 4.763725726436e+05 true resid norm 2.464285618036e-02 ||r(i)||/||b|| 2.464287532371e-02 > 3 KSP preconditioned resid norm 2.287746683380e+04 true resid norm 7.224823080100e-03 ||r(i)||/||b|| 7.224828692570e-03 > 4 KSP preconditioned resid norm 4.872858764091e+03 true resid norm 3.972261388893e-03 ||r(i)||/||b|| 3.972264474670e-03 > 5 KSP preconditioned resid norm 8.670449895323e+02 true resid norm 2.359005963873e-04 ||r(i)||/||b|| 2.359007796423e-04 > 6 KSP preconditioned resid norm 4.252589693890e+01 true resid norm 1.471904261226e-06 ||r(i)||/||b|| 1.471905404648e-06 > 7 KSP preconditioned resid norm 5.128476471782e+00 true resid norm 1.643725157865e-07 ||r(i)||/||b|| 1.643726434763e-07 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.311901915856e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.345765068989e+07 at iteration 8 > 8 KSP preconditioned resid norm 4.311901915856e-01 true resid norm 1.166123921637e-08 ||r(i)||/||b|| 1.166124827519e-08 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.373662391739e-09 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.356628084813e-02 at iteration 2 > 2 KSP unpreconditioned resid norm 2.373662391739e-09 true resid norm 2.373662391658e-09 ||r(i)||/||b|| 3.226562990941e-08 > > [0] SNESSolve_NEWTONLS(): iter=2, linear solve iterations=2 > [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.343326231305e-02 near zero implies inconsistent rhs > [0] SNESSolve_NEWTONLS(): fnorm=7.3566280848133728e-02, gnorm=7.2259942496422647e-02, ynorm=6.3156901950486099e+04, lssucceed=0 > 3 2r: 7.23E-02 2x: 3.70E+09 2u: 6.32E+04 ir: 4.52E-02 iu: 5.00E+04 rsn: 0 > [0] SNESComputeJacobian(): Rebuilding preconditioner > > Residual norms for flow_ solve. > 0 KSP unpreconditioned resid norm 7.225994249642e-02 true resid norm 7.225994249642e-02 ||r(i)||/||b|| 1.000000000000e+00 > Residual norms for flow_sub_0_galerkin_ solve. > 0 KSP preconditioned resid norm 7.705582590638e+05 true resid norm 9.649751442741e-01 ||r(i)||/||b|| 1.000000000000e+00 > 1 KSP preconditioned resid norm 2.444424220392e+04 true resid norm 8.243110200738e-03 ||r(i)||/||b|| 8.542303135630e-03 > 2 KSP preconditioned resid norm 2.080899648412e+03 true resid norm 7.642343147053e-04 ||r(i)||/||b|| 7.919730567570e-04 > 3 KSP preconditioned resid norm 9.911171129874e+02 true resid norm 5.904182179180e-05 ||r(i)||/||b|| 6.118481096859e-05 > 4 KSP preconditioned resid norm 5.258230282482e+02 true resid norm 2.043366677644e-04 ||r(i)||/||b|| 2.117532964210e-04 > 5 KSP preconditioned resid norm 5.522830460456e+01 true resid norm 1.710780366056e-05 ||r(i)||/||b|| 1.772875059225e-05 > 6 KSP preconditioned resid norm 5.922280741715e+00 true resid norm 1.543198740828e-06 ||r(i)||/||b|| 1.599210870855e-06 > 7 KSP preconditioned resid norm 3.339500859115e-01 true resid norm 1.221335666427e-07 ||r(i)||/||b|| 1.265665414984e-07 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 3.329208597672e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.705582590638e+05 at iteration 8 > 8 KSP preconditioned resid norm 3.329208597672e-02 true resid norm 9.758240835324e-09 ||r(i)||/||b|| 1.011242713683e-08 > [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.697128456432e-11 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.225994249642e-02 at iteration 1 > 1 KSP unpreconditioned resid norm 2.697128456432e-11 true resid norm 2.697128457142e-11 ||r(i)||/||b|| 3.732536124389e-10 > > [0] SNESSolve_NEWTONLS(): iter=3, linear solve iterations=1 > [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.329227684222e-02 near zero implies inconsistent rhs > [0] SNESSolve_NEWTONLS(): fnorm=7.2259942496422647e-02, gnorm=5.4435602192925014e-01, ynorm=2.7049750229137400e+04, lssucceed=0 > [0] SNESConvergedDefault(): Converged due to small update length: 2.704975022914e+04 < 1.000000000000e-05 * 3.702469482296e+09 > 4 2r: 5.44E-01 2x: 3.70E+09 2u: 2.70E+04 ir: 3.84E-01 iu: 2.34E+04 rsn: stol > Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 4 > > > As the simulation advances this behaviour leads to frequent time step cuts because of 8 subsequently failed Newton iterations, which brings the simulation practically to a halt. > > Is the Block Jacobi not a good choice? Better ASM with huge overlap? Or is there something wrong with my RHS? Maybe the SNES, SNESLS, KSP tolerances need better tuning? > > Grateful for any clarifying words! > Robert > > > My SNES_view is: > > > SNES Object: (flow_) 2 MPI processes > type: newtonls > maximum iterations=8, maximum function evaluations=10000 > tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 > total number of linear solver iterations=1 > total number of function evaluations=2 > norm schedule ALWAYS > SNESLineSearch Object: (flow_) 2 MPI processes > type: basic > maxstep=1.000000e+08, minlambda=1.000000e-05 > tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 > maximum iterations=40 > using user-defined precheck step > KSP Object: (flow_) 2 MPI processes > type: fgmres > GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > GMRES: happy breakdown tolerance 1e-30 > maximum iterations=200, initial guess is zero > tolerances: relative=1e-07, absolute=1e-50, divergence=10000. > right preconditioning > using UNPRECONDITIONED norm type for convergence test > PC Object: (flow_) 2 MPI processes > type: composite > Composite PC type - MULTIPLICATIVE > PCs on composite preconditioner follow > --------------------------------- > PC Object: (flow_sub_0_) 2 MPI processes > type: galerkin > Galerkin PC > KSP on Galerkin follow > --------------------------------- > KSP Object: (flow_sub_0_galerkin_) 2 MPI processes > type: gmres > GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement > GMRES: happy breakdown tolerance 1e-30 > maximum iterations=200, initial guess is zero > tolerances: relative=1e-07, absolute=1e-50, divergence=10000. > left preconditioning > using PRECONDITIONED norm type for convergence test > PC Object: (flow_sub_0_galerkin_) 2 MPI processes > type: hypre > HYPRE BoomerAMG preconditioning > HYPRE BoomerAMG: Cycle type V > HYPRE BoomerAMG: Maximum number of levels 25 > HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 > HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. > HYPRE BoomerAMG: Threshold for strong coupling 0.25 > HYPRE BoomerAMG: Interpolation truncation factor 0. > HYPRE BoomerAMG: Interpolation: max elements per row 0 > HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 > HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 > HYPRE BoomerAMG: Maximum row sums 0.9 > HYPRE BoomerAMG: Sweeps down 1 > HYPRE BoomerAMG: Sweeps up 1 > HYPRE BoomerAMG: Sweeps on coarse 1 > HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi > HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi > HYPRE BoomerAMG: Relax on coarse Gaussian-elimination > HYPRE BoomerAMG: Relax weight (all) 1. > HYPRE BoomerAMG: Outer relax weight (all) 1. > HYPRE BoomerAMG: Using CF-relaxation > HYPRE BoomerAMG: Not using more complex smoothers. > HYPRE BoomerAMG: Measure type local > HYPRE BoomerAMG: Coarsen type Falgout > HYPRE BoomerAMG: Interpolation type classical > linear system matrix = precond matrix: > Mat Object: 2 MPI processes > type: mpiaij > rows=8000, cols=8000 > total: nonzeros=53600, allocated nonzeros=53600 > total number of mallocs used during MatSetValues calls =0 > not using I-node (on process 0) routines > linear system matrix = precond matrix: > Mat Object: (flow_) 2 MPI processes > type: mpibaij > rows=24000, cols=24000, bs=3 > total: nonzeros=482400, allocated nonzeros=482400 > total number of mallocs used during MatSetValues calls =0 > PC Object: (flow_sub_1_) 2 MPI processes > type: bjacobi > block Jacobi: number of blocks = 2 > Local solve is same for all blocks, in the following KSP and PC objects: > KSP Object: (flow_sub_1_sub_) 1 MPI processes > type: preonly > maximum iterations=10000, initial guess is zero > tolerances: relative=1e-05, absolute=1e-50, divergence=10000. <------ not working: -flow_sub_1_sub_ksp_rtol 1e-7 > left preconditioning > using NONE norm type for convergence test > PC Object: (flow_sub_1_sub_) 1 MPI processes > type: lu > out-of-place factorization > tolerance for zero pivot 2.22045e-14 > matrix ordering: nd > factor fill ratio given 5., needed 18.3108 > Factored matrix follows: > Mat Object: 1 MPI processes > type: seqbaij > rows=12000, cols=12000, bs=3 > package used to perform factorization: petsc > total: nonzeros=4350654, allocated nonzeros=4350654 > total number of mallocs used during MatSetValues calls =0 > block size is 3 > linear system matrix = precond matrix: > Mat Object: (flow_) 1 MPI processes > type: seqbaij > rows=12000, cols=12000, bs=3 > total: nonzeros=237600, allocated nonzeros=237600 > total number of mallocs used during MatSetValues calls =0 > block size is 3 > linear system matrix = precond matrix: > Mat Object: (flow_) 2 MPI processes > type: mpibaij > rows=24000, cols=24000, bs=3 > total: nonzeros=482400, allocated nonzeros=482400 > total number of mallocs used during MatSetValues calls =0 > --------------------------------- > linear system matrix = precond matrix: > Mat Object: (flow_) 2 MPI processes > type: mpibaij > rows=24000, cols=24000, bs=3 > total: nonzeros=482400, allocated nonzeros=482400 > total number of mallocs used during MatSetValues calls =0 > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Fri Jul 7 10:34:05 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 7 Jul 2017 10:34:05 -0500 Subject: [petsc-users] -snes_fd for problems with residuals with non-continuous first derivative? In-Reply-To: References: <8EEBC84F-F0BB-4E7F-9FAA-8D35B86A15BC@mcs.anl.gov> Message-ID: <70D8C094-7341-4B50-BCEF-3B416BC7FC22@mcs.anl.gov> Send the output with the monitoring turned on -snes_monitor -snes_linesearch_monitor > On Jul 7, 2017, at 4:54 AM, Maximilian Hartig wrote: > > If I set the function count higher it results in a diverged line search error. And if I reduce the absolute residual tolerance it continues for one or two more timesteps before it fails again. > > Thanks, > Max > > 2017-07-05 20:24 GMT+02:00 Barry Smith : > > > 39 SNES Function norm 3.758101652998e-08 > > 0 KSP preconditioned resid norm 1.931834799209e-02 true resid norm 3.758101652998e-08 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 5.958979968059e-16 true resid norm 2.588244438237e-18 ||r(i)||/||b|| 6.887105983875e-11 > > The SNES function norm is pretty small here are you sure you need it smaller. > > > Nonlinear solve did not converge due to DIVERGED_FUNCTION_COUNT i > > You should just set the function count to say 1 billion so it doesn't stop the solution process. > > > > > > On Jul 5, 2017, at 11:24 AM, Maximilian Hartig wrote: > > > > The solver goes on for some timesteps, then it gets hung up in step 10. The output is as follows: > > > > 28 SNES Function norm 7.825649542035e-06 > > 0 KSP preconditioned resid norm 5.335581451751e+00 true resid norm 7.825649542035e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 3.875747966342e-13 true resid norm 3.082821236889e-15 ||r(i)||/||b|| 3.939380648635e-10 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 29 SNES Function norm 7.825641650401e-06 > > 0 KSP preconditioned resid norm 5.335568660325e+00 true resid norm 7.825641650401e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 1.169064646930e-13 true resid norm 2.949237553452e-15 ||r(i)||/||b|| 3.768684646199e-10 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 30 SNES Function norm 7.825633758775e-06 > > 0 KSP preconditioned resid norm 5.335575714181e+00 true resid norm 7.825633758775e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 3.626528075820e-13 true resid norm 7.454935467844e-16 ||r(i)||/||b|| 9.526302530432e-11 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 31 SNES Function norm 7.825625867144e-06 > > 0 KSP preconditioned resid norm 5.335574289757e+00 true resid norm 7.825625867144e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 1.220021201426e-13 true resid norm 6.140701297052e-16 ||r(i)||/||b|| 7.846913973787e-11 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 32 SNES Function norm 7.825617975525e-06 > > 0 KSP preconditioned resid norm 5.335556211708e+00 true resid norm 7.825617975525e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 3.238615954344e-14 true resid norm 1.639170816829e-15 ||r(i)||/||b|| 2.094621564655e-10 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 33 SNES Function norm 7.825610083913e-06 > > 0 KSP preconditioned resid norm 5.335545135100e+00 true resid norm 7.825610083913e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 8.328043430360e-14 true resid norm 7.902728010647e-16 ||r(i)||/||b|| 1.009854557780e-10 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 34 SNES Function norm 7.825609294752e-06 > > 0 KSP preconditioned resid norm 5.335519330054e+00 true resid norm 7.825609294752e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 1.176339150741e-13 true resid norm 2.137240765649e-15 ||r(i)||/||b|| 2.731085446703e-10 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 35 SNES Function norm 7.825608505592e-06 > > 0 KSP preconditioned resid norm 5.335552250936e+00 true resid norm 7.825608505592e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 2.388837462586e-13 true resid norm 3.899327292367e-16 ||r(i)||/||b|| 4.982778386601e-11 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 36 SNES Function norm 7.825607716432e-06 > > 0 KSP preconditioned resid norm 1.017554264638e-01 true resid norm 7.825607716432e-06 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 2.758703070887e-14 true resid norm 1.990491888342e-16 ||r(i)||/||b|| 2.543562059932e-11 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 37 SNES Function norm 3.815837655573e-08 > > 0 KSP preconditioned resid norm 7.197730150406e+00 true resid norm 3.815837655573e-08 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 7.114599045039e-12 true resid norm 4.763264085142e-16 ||r(i)||/||b|| 1.248287929175e-08 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 38 SNES Function norm 3.790245121284e-08 > > 0 KSP preconditioned resid norm 7.127517791828e+00 true resid norm 3.790245121284e-08 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 2.500976336448e-11 true resid norm 1.692661771456e-15 ||r(i)||/||b|| 4.465837214461e-08 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > 39 SNES Function norm 3.758101652998e-08 > > 0 KSP preconditioned resid norm 1.931834799209e-02 true resid norm 3.758101652998e-08 ||r(i)||/||b|| 1.000000000000e+00 > > 1 KSP preconditioned resid norm 5.958979968059e-16 true resid norm 2.588244438237e-18 ||r(i)||/||b|| 6.887105983875e-11 > > Linear solve converged due to CONVERGED_RTOL iterations 1 > > Nonlinear solve did not converge due to DIVERGED_FUNCTION_COUNT iterations 39 > > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > > [0]PETSC ERROR: > > [0]PETSC ERROR: TSStep has failed due to DIVERGED_NONLINEAR_SOLVE, increase -ts_max_snes_failures or make negative to attempt recovery > > [0]PETSC ERROR: See http://www.mcs.anl.gov/petsc/documentation/faq.html for trouble shooting. > > [0]PETSC ERROR: Petsc Development GIT revision: v3.7.5-3342-gb122798 GIT Date: 2017-03-22 17:42:51 -0500 > > [0]PETSC ERROR: ./miniFEM on a arch-linux2-c-debug named iket127138 by hartig Wed Jul 5 18:09:53 2017 > > [0]PETSC ERROR: Configure options PETSC_ARCH=arch-linux2-c-debug --with-cc=mpigcc --with-cxx=mpicxx --with-fc=mpif90 --download-ml --download-parmetis --download-metis --download-hypre --download-mumps --download-scalapack > > [0]PETSC ERROR: #1 TSStep() line 3818 in /home/hartig/petsc/src/ts/interface/ts.c > > [0]PETSC ERROR: #2 TSSolve() line 4054 in /home/hartig/petsc/src/ts/interface/ts.c > > [0]PETSC ERROR: #3 main() line 1829 in /home/hartig/Nextcloud/Dissertation/Code/Debugging/miniFEM.c > > [0]PETSC ERROR: PETSc Option Table entries: > > [0]PETSC ERROR: -def_petscspace_order 2 > > [0]PETSC ERROR: -eplast_petscspace_order 2 > > [0]PETSC ERROR: -ksp_converged_reason > > [0]PETSC ERROR: -ksp_monitor_true_residual > > [0]PETSC ERROR: -pc_type lu > > [0]PETSC ERROR: -plast > > [0]PETSC ERROR: -snes_converged_reason > > [0]PETSC ERROR: -snes_fd > > [0]PETSC ERROR: -snes_monitor > > [0]PETSC ERROR: -snes_type newtonls > > [0]PETSC ERROR: -ts_monitor > > [0]PETSC ERROR: -vel_petscspace_order 2 > > [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- > > > > > > Thanks, > > Max > > > > > > 2017-06-30 17:14 GMT+02:00 Barry Smith : > > > > What is the output from > > > > -snes_monitor -ksp_monitor_true_residual -pc_type lu -ksp_converged_reason -snes_converged_reason > > > > > > > On Jun 30, 2017, at 3:45 AM, Maximilian Hartig wrote: > > > > > > Hello, > > > > > > I?m trying to implement plasticity and have problems getting the Petsc SNES to converge. To check if my residual formulation is correct I tried running with -snes_fd for an easy example as the Petsc FAQ suggest. I cannot seem to get the solver to converge at any cost. > > > I already tried to impose bounds on the solution and moved to vinewtonrsls as a nonlinear solver. I checked and rechecked my residuals but I do not find an error there. I now have the suspicion that the -snes_fd option is not made for handling residuals who?s first derivatives are not continuous (e.g. have an ?if? condition in them for the plasticity/ flow-condition). Can you confirm my suspicion? And is there another way to test my residual formulation separate from my hand-coded jacobian? > > > > > > > > > Thanks, > > > Max > > > > > > From knepley at gmail.com Fri Jul 7 11:07:38 2017 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 7 Jul 2017 09:07:38 -0700 Subject: [petsc-users] Understanding preallocation for MPI In-Reply-To: References: Message-ID: On Fri, Jul 7, 2017 at 2:49 AM, Dave May wrote: > On Fri, 7 Jul 2017 at 11:31, Florian Lindner wrote: > >> Hello, >> >> I'm having some struggle understanding the preallocation for MPIAIJ >> matrices, especially when a value is in off-diagonal >> vs. diagonal block. >> >> The small example program is at https://pastebin.com/67dXnGm3 >> >> In general it should be parallel, but right now I just run it in serial. > > > When you run this code in serial, the mat type will be MATSEQAIJ. Hence, > the call to MatMPIAIJSetPreallocation() will have no effect because the mat > type does not match MPIAIJ. As a result, your code doesn't perform any > preallocation for SEQAIJ matrices. > > In addition to calling MatMPIAIJSetPreallocation(), add a call to > MatSEQAIJSetPreallocation. > To make it easier we now provide http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatXAIJSetPreallocation.html Matt > Thanks, > Dave > > >> >> According to my understanding of >> >> http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/ >> Mat/MatMPIAIJSetPreallocation.html >> >> a entry is in the diagonal submatrix, if its row is in the OwnershipRange >> and its column is in OwnershipRangeColumn. >> That also means that in a serial run, there is only a diagonal submatrix. >> >> However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when >> >> Inserting 6 elements in row 2, though I have exactly >> >> 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal >> submatrix of row 2) >> >> Error is: >> >> [0]PETSC ERROR: Argument out of range >> [0]PETSC ERROR: New nonzero at (2,5) caused a malloc >> Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn >> off this check >> >> >> What is wrong with my understanding? >> >> Thanks, >> 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 http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Fri Jul 7 11:10:33 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 7 Jul 2017 11:10:33 -0500 Subject: [petsc-users] CPR-AMG: SNES with two cores worse than with one In-Reply-To: <981f495d-529c-88be-bdaa-4db736e7f357@opengosim.com> References: <293da4be-1eaa-9ac0-54fe-171832a5b4af@opengosim.com> <981f495d-529c-88be-bdaa-4db736e7f357@opengosim.com> Message-ID: I don't have a clue. It looks like the np 2 case just takes a different trajectory that runs into trouble that doesn't happen to np 1. Since the linear solves give very good convergence for both np 2 and np 1 I don't think the preconditioner is really the "problem". I absolutely do not like the fact that the code is not using a line search. If you look at even the sequential case SNES is sometimes stopping due to snorm even though the function norm has actually increased. Frankly I'm very suspicious of the "solution" of the time integration, it is too much "hit the engine a few times with the hammer until it does what it wants" engineering. What happens if you run the 1 and 2 process case with the "default" Pflotran linear solver? > On Jul 7, 2017, at 6:05 AM, Robert Annewandter wrote: > > Yes indeed, PFLOTRAN cuts timestep after 8 failed iterations of SNES. > > I've rerun with -snes_monitor (attached with canonical suffix), their -pc_type is always PCBJACOBI + PCLU (though we'd like to try SUPERLU in the future, however it works only with -mat_type aij..) > > > The sequential and parallel runs I did with > > -ksp_type preonly -pc_type lu -pc_factor_nonzeros_along_diagonal -snes_monitor > > and > > -ksp_type preonly -pc_type bjacobi -sub_pc_type lu -sub_pc_factor_nonzeros_along_diagonal -snes_monitor > > As expected, the sequential are bot identical and the parallel takes half the time compared to sequential. > > > > > On 07/07/17 01:20, Barry Smith wrote: >> Looks like PFLOTRAN has a maximum number of SNES iterations as 8 and cuts the timestep if that fails. >> >> Please run with -snes_monitor I don't understand the strange densely packed information that PFLOTRAN is printing. >> >> It looks like the linear solver is converging fine in parallel, normally then there is absolutely no reason that the Newton should behave different on 2 processors than 1 unless there is something wrong with the Jacobian. What is the -pc_type for the two cases LU or your fancy thing? >> >> Please run sequential and parallel with -pc_type lu and also with -snes_monitor. We need to fix all the knobs but one in order to understand what is going on. >> >> >> Barry >> >> >> >> >>> On Jul 6, 2017, at 5:11 PM, Robert Annewandter >>> wrote: >>> >>> Thanks Barry! >>> >>> I've attached log files for np = 1 (SNES time: 218 s) and np = 2 (SNES time: 600 s). PFLOTRAN final output: >>> >>> NP 1 >>> >>> FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 >>> FLOW TS BE Wasted Linear Iterations = 0 >>> FLOW TS BE SNES time = 218.9 seconds >>> >>> NP 2 >>> >>> FLOW TS BE steps = 67 newton = 176 linear = 314 cuts = 13 >>> FLOW TS BE Wasted Linear Iterations = 208 >>> FLOW TS BE SNES time = 600.0 seconds >>> >>> >>> Robert >>> >>> On 06/07/17 21:24, Barry Smith wrote: >>> >>>> So on one process the outer linear solver takes a single iteration this is because the block Jacobi with LU and one block is a direct solver. >>>> >>>> >>>> >>>>> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >>>>> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 >>>>> >>>>> >>>> On two processes the outer linear solver takes a few iterations to solver, this is to be expected. >>>> >>>> But what you sent doesn't give any indication about SNES not converging. Please turn off all inner linear solver monitoring and just run with -ksp_monitor_true_residual -snes_monitor -snes_lineseach_monitor -snes_converged_reason >>>> >>>> Barry >>>> >>>> >>>> >>>> >>>> >>>>> On Jul 6, 2017, at 2:03 PM, Robert Annewandter >>>>> >>>>> wrote: >>>>> >>>>> Hi all, >>>>> >>>>> I like to understand why the SNES of my CPR-AMG Two-Stage Preconditioner (with KSPFGMRES + multipl. PCComposite (PCGalerkin with KSPGMRES + BoomerAMG, PCBJacobi + PCLU init) on a 24,000 x 24,000 matrix) struggles to converge when using two cores instead of one. Because of the adaptive time stepping of the Newton, this leads to severe cuts in time step. >>>>> >>>>> This is how I run it with two cores >>>>> >>>>> mpirun \ >>>>> -n 2 pflotran \ >>>>> -pflotranin het.pflinput \ >>>>> -ksp_monitor_true_residual \ >>>>> -flow_snes_view \ >>>>> -flow_snes_converged_reason \ >>>>> -flow_sub_1_pc_type bjacobi \ >>>>> -flow_sub_1_sub_pc_type lu \ >>>>> -flow_sub_1_sub_pc_factor_pivot_in_blocks true\ >>>>> -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ >>>>> -options_left \ >>>>> -log_summary \ >>>>> -info >>>>> >>>>> >>>>> With one core I get (after grepping the crap away from -info): >>>>> >>>>> Step 32 Time= 1.80000E+01 >>>>> >>>>> [...] >>>>> >>>>> 0 2r: 1.58E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 7.18E-03 iu: 0.00E+00 rsn: 0 >>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>> Residual norms for flow_ solve. >>>>> 0 KSP unpreconditioned resid norm 1.581814306485e-02 true resid norm 1.581814306485e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 5.697603110484e+07 true resid norm 5.175721849125e+03 ||r(i)||/||b|| 5.037527476892e+03 >>>>> 1 KSP preconditioned resid norm 5.041509073319e+06 true resid norm 3.251596928176e+02 ||r(i)||/||b|| 3.164777657484e+02 >>>>> 2 KSP preconditioned resid norm 1.043761838360e+06 true resid norm 8.957519558348e+01 ||r(i)||/||b|| 8.718349288342e+01 >>>>> 3 KSP preconditioned resid norm 1.129189815646e+05 true resid norm 2.722436912053e+00 ||r(i)||/||b|| 2.649746479496e+00 >>>>> 4 KSP preconditioned resid norm 8.829637298082e+04 true resid norm 8.026373593492e+00 ||r(i)||/||b|| 7.812065388300e+00 >>>>> 5 KSP preconditioned resid norm 6.506021637694e+04 true resid norm 3.479889319880e+00 ||r(i)||/||b|| 3.386974527698e+00 >>>>> 6 KSP preconditioned resid norm 6.392263200180e+04 true resid norm 3.819202631980e+00 ||r(i)||/||b|| 3.717228003987e+00 >>>>> 7 KSP preconditioned resid norm 2.464946645480e+04 true resid norm 7.329964753388e-01 ||r(i)||/||b|| 7.134251013911e-01 >>>>> 8 KSP preconditioned resid norm 2.603879153772e+03 true resid norm 2.035525412004e-02 ||r(i)||/||b|| 1.981175861414e-02 >>>>> 9 KSP preconditioned resid norm 1.774410462754e+02 true resid norm 3.001214973121e-03 ||r(i)||/||b|| 2.921081026352e-03 >>>>> 10 KSP preconditioned resid norm 1.664227038378e+01 true resid norm 3.413136309181e-04 ||r(i)||/||b|| 3.322003855903e-04 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 1.131868956745e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 2.067297386780e+07 at iteration 11 >>>>> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >>>>> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 >>>>> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=1 >>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 3.590873180642e-01 near zero implies inconsistent rhs >>>>> [0] SNESSolve_NEWTONLS(): fnorm=1.5818143064846742e-02, gnorm=1.0695649833687331e-02, ynorm=4.6826522561266171e+02, lssucceed=0 >>>>> [0] SNESConvergedDefault(): Converged due to small update length: 4.682652256127e+02 < 1.000000000000e-05 * 3.702480426117e+09 >>>>> 1 2r: 1.07E-02 2x: 3.70E+09 2u: 4.68E+02 ir: 5.05E-03 iu: 4.77E+01 rsn: stol >>>>> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 >>>>> >>>>> >>>>> >>>>> But with two cores I get: >>>>> >>>>> >>>>> Step 32 Time= 1.80000E+01 >>>>> >>>>> [...] >>>>> >>>>> 0 2r: 6.16E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 3.63E-03 iu: 0.00E+00 rsn: 0 >>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>> >>>>> Residual norms for flow_ solve. >>>>> 0 KSP unpreconditioned resid norm 6.162760088924e-03 true resid norm 6.162760088924e-03 ||r(i)||/||b|| 1.000000000000e+00 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 8.994949630499e+08 true resid norm 7.982144380936e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 8.950556502615e+08 true resid norm 1.550138696155e+00 ||r(i)||/||b|| 1.942007839218e+00 >>>>> 2 KSP preconditioned resid norm 1.044849684205e+08 true resid norm 2.166193480531e+00 ||r(i)||/||b|| 2.713798920631e+00 >>>>> 3 KSP preconditioned resid norm 8.209708619718e+06 true resid norm 3.076045005154e-01 ||r(i)||/||b|| 3.853657436340e-01 >>>>> 4 KSP preconditioned resid norm 3.027461352422e+05 true resid norm 1.207731865714e-02 ||r(i)||/||b|| 1.513041869549e-02 >>>>> 5 KSP preconditioned resid norm 1.595302164817e+04 true resid norm 4.123713694368e-04 ||r(i)||/||b|| 5.166172769585e-04 >>>>> 6 KSP preconditioned resid norm 1.898935810797e+03 true resid norm 8.275885058330e-05 ||r(i)||/||b|| 1.036799719897e-04 >>>>> 7 KSP preconditioned resid norm 1.429881682558e+02 true resid norm 4.751240525466e-06 ||r(i)||/||b|| 5.952335987324e-06 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 8.404003313455e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.994949630499e+08 at iteration 8 >>>>> 8 KSP preconditioned resid norm 8.404003313455e+00 true resid norm 3.841921844578e-07 ||r(i)||/||b|| 4.813145016211e-07 >>>>> 1 KSP unpreconditioned resid norm 6.162162548202e-03 true resid norm 6.162162548202e-03 ||r(i)||/||b|| 9.999030400804e-01 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 4.360556381209e+07 true resid norm 1.000000245433e+00 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 5.385519331932e+06 true resid norm 8.785183939860e-02 ||r(i)||/||b|| 8.785181783689e-02 >>>>> 2 KSP preconditioned resid norm 4.728931283459e+05 true resid norm 2.008708805316e-02 ||r(i)||/||b|| 2.008708312313e-02 >>>>> 3 KSP preconditioned resid norm 2.734215698319e+04 true resid norm 6.418720397673e-03 ||r(i)||/||b|| 6.418718822309e-03 >>>>> 4 KSP preconditioned resid norm 1.002270029334e+04 true resid norm 4.040289515991e-03 ||r(i)||/||b|| 4.040288524372e-03 >>>>> 5 KSP preconditioned resid norm 1.321280190971e+03 true resid norm 1.023292238313e-04 ||r(i)||/||b|| 1.023291987163e-04 >>>>> 6 KSP preconditioned resid norm 6.594292964815e+01 true resid norm 1.877106733170e-06 ||r(i)||/||b|| 1.877106272467e-06 >>>>> 7 KSP preconditioned resid norm 7.816325147216e+00 true resid norm 2.552611664980e-07 ||r(i)||/||b|| 2.552611038486e-07 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.391568446109e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.360556381209e+07 at iteration 8 >>>>> 8 KSP preconditioned resid norm 6.391568446109e-01 true resid norm 1.680724939670e-08 ||r(i)||/||b|| 1.680724527166e-08 >>>>> 2 KSP unpreconditioned resid norm 4.328902922753e-07 true resid norm 4.328902922752e-07 ||r(i)||/||b|| 7.024292460341e-05 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 8.794597825780e+08 true resid norm 1.000000094566e+00 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 8.609906572102e+08 true resid norm 2.965044981249e+00 ||r(i)||/||b|| 2.965044700856e+00 >>>>> 2 KSP preconditioned resid norm 9.318108989314e+07 true resid norm 1.881262939380e+00 ||r(i)||/||b|| 1.881262761477e+00 >>>>> 3 KSP preconditioned resid norm 6.908723262483e+06 true resid norm 2.639592490398e-01 ||r(i)||/||b|| 2.639592240782e-01 >>>>> 4 KSP preconditioned resid norm 2.651677791227e+05 true resid norm 9.736480169584e-03 ||r(i)||/||b|| 9.736479248845e-03 >>>>> 5 KSP preconditioned resid norm 1.192178471172e+04 true resid norm 3.082839752692e-04 ||r(i)||/||b|| 3.082839461160e-04 >>>>> 6 KSP preconditioned resid norm 1.492201446262e+03 true resid norm 4.633866284506e-05 ||r(i)||/||b|| 4.633865846301e-05 >>>>> 7 KSP preconditioned resid norm 1.160670017241e+02 true resid norm 2.821157348522e-06 ||r(i)||/||b|| 2.821157081737e-06 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.447568262216e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.794597825780e+08 at iteration 8 >>>>> 8 KSP preconditioned resid norm 6.447568262216e+00 true resid norm 1.516068561348e-07 ||r(i)||/||b|| 1.516068417980e-07 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.135731709822e-15 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.162760088924e-03 at iteration 3 >>>>> 3 KSP unpreconditioned resid norm 6.135731709822e-15 true resid norm 1.142020328809e-14 ||r(i)||/||b|| 1.853098793933e-12 >>>>> >>>>> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=3 >>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 1.998388224666e-02 near zero implies inconsistent rhs >>>>> [0] SNESSolve_NEWTONLS(): fnorm=6.1627600889243711e-03, gnorm=1.0406503258190572e-02, ynorm=6.2999025681245366e+04, lssucceed=0 >>>>> 1 2r: 1.04E-02 2x: 3.70E+09 2u: 6.30E+04 ir: 6.54E-03 iu: 5.00E+04 rsn: 0 >>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>> >>>>> Residual norms for flow_ solve. >>>>> 0 KSP unpreconditioned resid norm 1.040650325819e-02 true resid norm 1.040650325819e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 6.758906811264e+07 true resid norm 9.814998431686e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 2.503922806424e+06 true resid norm 2.275130113021e-01 ||r(i)||/||b|| 2.318013730574e-01 >>>>> 2 KSP preconditioned resid norm 3.316753614870e+05 true resid norm 3.820733530238e-02 ||r(i)||/||b|| 3.892750016040e-02 >>>>> 3 KSP preconditioned resid norm 2.956751700483e+04 true resid norm 2.143772538677e-03 ||r(i)||/||b|| 2.184180215207e-03 >>>>> 4 KSP preconditioned resid norm 1.277067042524e+03 true resid norm 9.093614251311e-05 ||r(i)||/||b|| 9.265018547485e-05 >>>>> 5 KSP preconditioned resid norm 1.060996002446e+02 true resid norm 1.042893700050e-05 ||r(i)||/||b|| 1.062551061326e-05 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 5.058127343285e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.758906811264e+07 at iteration 6 >>>>> 6 KSP preconditioned resid norm 5.058127343285e+00 true resid norm 4.054770602120e-07 ||r(i)||/||b|| 4.131198420807e-07 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.449606189225e-10 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.040650325819e-02 at iteration 1 >>>>> 1 KSP unpreconditioned resid norm 4.449606189225e-10 true resid norm 4.449606189353e-10 ||r(i)||/||b|| 4.275793779098e-08 >>>>> >>>>> [0] SNESSolve_NEWTONLS(): iter=1, linear solve iterations=1 >>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.300066663571e-02 near zero implies inconsistent rhs >>>>> [0] SNESSolve_NEWTONLS(): fnorm=1.0406503258190572e-02, gnorm=7.3566280848133728e-02, ynorm=7.9500485128639993e+04, lssucceed=0 >>>>> 2 2r: 7.36E-02 2x: 3.70E+09 2u: 7.95E+04 ir: 4.62E-02 iu: 5.00E+04 rsn: 0 >>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>> >>>>> Residual norms for flow_ solve. >>>>> 0 KSP unpreconditioned resid norm 7.356628084813e-02 true resid norm 7.356628084813e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 7.253424029194e+06 true resid norm 9.647008645250e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 7.126940190688e+06 true resid norm 1.228009197928e+00 ||r(i)||/||b|| 1.272942984800e+00 >>>>> 2 KSP preconditioned resid norm 9.391591432635e+05 true resid norm 7.804929162756e-01 ||r(i)||/||b|| 8.090517433711e-01 >>>>> 3 KSP preconditioned resid norm 6.538499674761e+04 true resid norm 5.503467432893e-02 ||r(i)||/||b|| 5.704843475602e-02 >>>>> 4 KSP preconditioned resid norm 1.593713396575e+04 true resid norm 8.902701363763e-02 ||r(i)||/||b|| 9.228457951208e-02 >>>>> 5 KSP preconditioned resid norm 4.837260621464e+02 true resid norm 2.966772992825e-03 ||r(i)||/||b|| 3.075329464213e-03 >>>>> 6 KSP preconditioned resid norm 1.681372767335e+02 true resid norm 5.312467443025e-04 ||r(i)||/||b|| 5.506854651406e-04 >>>>> 7 KSP preconditioned resid norm 1.271478850717e+01 true resid norm 2.123810020488e-05 ||r(i)||/||b|| 2.201521838103e-05 >>>>> 8 KSP preconditioned resid norm 1.262723712696e+00 true resid norm 1.150572715331e-06 ||r(i)||/||b|| 1.192673042641e-06 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 9.053072585125e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.253424029194e+06 at iteration 9 >>>>> 9 KSP preconditioned resid norm 9.053072585125e-02 true resid norm 9.475050575058e-08 ||r(i)||/||b|| 9.821749853747e-08 >>>>> 1 KSP unpreconditioned resid norm 8.171589173162e-03 true resid norm 8.171589173162e-03 ||r(i)||/||b|| 1.110779161180e-01 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 4.345765068989e+07 true resid norm 9.999992231691e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 5.388715093466e+06 true resid norm 8.125387327699e-02 ||r(i)||/||b|| 8.125393639755e-02 >>>>> 2 KSP preconditioned resid norm 4.763725726436e+05 true resid norm 2.464285618036e-02 ||r(i)||/||b|| 2.464287532371e-02 >>>>> 3 KSP preconditioned resid norm 2.287746683380e+04 true resid norm 7.224823080100e-03 ||r(i)||/||b|| 7.224828692570e-03 >>>>> 4 KSP preconditioned resid norm 4.872858764091e+03 true resid norm 3.972261388893e-03 ||r(i)||/||b|| 3.972264474670e-03 >>>>> 5 KSP preconditioned resid norm 8.670449895323e+02 true resid norm 2.359005963873e-04 ||r(i)||/||b|| 2.359007796423e-04 >>>>> 6 KSP preconditioned resid norm 4.252589693890e+01 true resid norm 1.471904261226e-06 ||r(i)||/||b|| 1.471905404648e-06 >>>>> 7 KSP preconditioned resid norm 5.128476471782e+00 true resid norm 1.643725157865e-07 ||r(i)||/||b|| 1.643726434763e-07 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.311901915856e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.345765068989e+07 at iteration 8 >>>>> 8 KSP preconditioned resid norm 4.311901915856e-01 true resid norm 1.166123921637e-08 ||r(i)||/||b|| 1.166124827519e-08 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.373662391739e-09 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.356628084813e-02 at iteration 2 >>>>> 2 KSP unpreconditioned resid norm 2.373662391739e-09 true resid norm 2.373662391658e-09 ||r(i)||/||b|| 3.226562990941e-08 >>>>> >>>>> [0] SNESSolve_NEWTONLS(): iter=2, linear solve iterations=2 >>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.343326231305e-02 near zero implies inconsistent rhs >>>>> [0] SNESSolve_NEWTONLS(): fnorm=7.3566280848133728e-02, gnorm=7.2259942496422647e-02, ynorm=6.3156901950486099e+04, lssucceed=0 >>>>> 3 2r: 7.23E-02 2x: 3.70E+09 2u: 6.32E+04 ir: 4.52E-02 iu: 5.00E+04 rsn: 0 >>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>> >>>>> Residual norms for flow_ solve. >>>>> 0 KSP unpreconditioned resid norm 7.225994249642e-02 true resid norm 7.225994249642e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 7.705582590638e+05 true resid norm 9.649751442741e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 2.444424220392e+04 true resid norm 8.243110200738e-03 ||r(i)||/||b|| 8.542303135630e-03 >>>>> 2 KSP preconditioned resid norm 2.080899648412e+03 true resid norm 7.642343147053e-04 ||r(i)||/||b|| 7.919730567570e-04 >>>>> 3 KSP preconditioned resid norm 9.911171129874e+02 true resid norm 5.904182179180e-05 ||r(i)||/||b|| 6.118481096859e-05 >>>>> 4 KSP preconditioned resid norm 5.258230282482e+02 true resid norm 2.043366677644e-04 ||r(i)||/||b|| 2.117532964210e-04 >>>>> 5 KSP preconditioned resid norm 5.522830460456e+01 true resid norm 1.710780366056e-05 ||r(i)||/||b|| 1.772875059225e-05 >>>>> 6 KSP preconditioned resid norm 5.922280741715e+00 true resid norm 1.543198740828e-06 ||r(i)||/||b|| 1.599210870855e-06 >>>>> 7 KSP preconditioned resid norm 3.339500859115e-01 true resid norm 1.221335666427e-07 ||r(i)||/||b|| 1.265665414984e-07 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 3.329208597672e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.705582590638e+05 at iteration 8 >>>>> 8 KSP preconditioned resid norm 3.329208597672e-02 true resid norm 9.758240835324e-09 ||r(i)||/||b|| 1.011242713683e-08 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.697128456432e-11 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.225994249642e-02 at iteration 1 >>>>> 1 KSP unpreconditioned resid norm 2.697128456432e-11 true resid norm 2.697128457142e-11 ||r(i)||/||b|| 3.732536124389e-10 >>>>> >>>>> [0] SNESSolve_NEWTONLS(): iter=3, linear solve iterations=1 >>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.329227684222e-02 near zero implies inconsistent rhs >>>>> [0] SNESSolve_NEWTONLS(): fnorm=7.2259942496422647e-02, gnorm=5.4435602192925014e-01, ynorm=2.7049750229137400e+04, lssucceed=0 >>>>> [0] SNESConvergedDefault(): Converged due to small update length: 2.704975022914e+04 < 1.000000000000e-05 * 3.702469482296e+09 >>>>> 4 2r: 5.44E-01 2x: 3.70E+09 2u: 2.70E+04 ir: 3.84E-01 iu: 2.34E+04 rsn: stol >>>>> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 4 >>>>> >>>>> >>>>> As the simulation advances this behaviour leads to frequent time step cuts because of 8 subsequently failed Newton iterations, which brings the simulation practically to a halt. >>>>> >>>>> Is the Block Jacobi not a good choice? Better ASM with huge overlap? Or is there something wrong with my RHS? Maybe the SNES, SNESLS, KSP tolerances need better tuning? >>>>> >>>>> Grateful for any clarifying words! >>>>> Robert >>>>> >>>>> >>>>> My SNES_view is: >>>>> >>>>> >>>>> SNES Object: (flow_) 2 MPI processes >>>>> type: newtonls >>>>> maximum iterations=8, maximum function evaluations=10000 >>>>> tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 >>>>> total number of linear solver iterations=1 >>>>> total number of function evaluations=2 >>>>> norm schedule ALWAYS >>>>> SNESLineSearch Object: (flow_) 2 MPI processes >>>>> type: basic >>>>> maxstep=1.000000e+08, minlambda=1.000000e-05 >>>>> tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 >>>>> maximum iterations=40 >>>>> using user-defined precheck step >>>>> KSP Object: (flow_) 2 MPI processes >>>>> type: fgmres >>>>> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >>>>> GMRES: happy breakdown tolerance 1e-30 >>>>> maximum iterations=200, initial guess is zero >>>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>>> right preconditioning >>>>> using UNPRECONDITIONED norm type for convergence test >>>>> PC Object: (flow_) 2 MPI processes >>>>> type: composite >>>>> Composite PC type - MULTIPLICATIVE >>>>> PCs on composite preconditioner follow >>>>> --------------------------------- >>>>> PC Object: (flow_sub_0_) 2 MPI processes >>>>> type: galerkin >>>>> Galerkin PC >>>>> KSP on Galerkin follow >>>>> --------------------------------- >>>>> KSP Object: (flow_sub_0_galerkin_) 2 MPI processes >>>>> type: gmres >>>>> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >>>>> GMRES: happy breakdown tolerance 1e-30 >>>>> maximum iterations=200, initial guess is zero >>>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>>> left preconditioning >>>>> using PRECONDITIONED norm type for convergence test >>>>> PC Object: (flow_sub_0_galerkin_) 2 MPI processes >>>>> type: hypre >>>>> HYPRE BoomerAMG preconditioning >>>>> HYPRE BoomerAMG: Cycle type V >>>>> HYPRE BoomerAMG: Maximum number of levels 25 >>>>> HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 >>>>> HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. >>>>> HYPRE BoomerAMG: Threshold for strong coupling 0.25 >>>>> HYPRE BoomerAMG: Interpolation truncation factor 0. >>>>> HYPRE BoomerAMG: Interpolation: max elements per row 0 >>>>> HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 >>>>> HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 >>>>> HYPRE BoomerAMG: Maximum row sums 0.9 >>>>> HYPRE BoomerAMG: Sweeps down 1 >>>>> HYPRE BoomerAMG: Sweeps up 1 >>>>> HYPRE BoomerAMG: Sweeps on coarse 1 >>>>> HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi >>>>> HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi >>>>> HYPRE BoomerAMG: Relax on coarse Gaussian-elimination >>>>> HYPRE BoomerAMG: Relax weight (all) 1. >>>>> HYPRE BoomerAMG: Outer relax weight (all) 1. >>>>> HYPRE BoomerAMG: Using CF-relaxation >>>>> HYPRE BoomerAMG: Not using more complex smoothers. >>>>> HYPRE BoomerAMG: Measure type local >>>>> HYPRE BoomerAMG: Coarsen type Falgout >>>>> HYPRE BoomerAMG: Interpolation type classical >>>>> linear system matrix = precond matrix: >>>>> Mat Object: 2 MPI processes >>>>> type: mpiaij >>>>> rows=8000, cols=8000 >>>>> total: nonzeros=53600, allocated nonzeros=53600 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> not using I-node (on process 0) routines >>>>> linear system matrix = precond matrix: >>>>> Mat Object: (flow_) 2 MPI processes >>>>> type: mpibaij >>>>> rows=24000, cols=24000, bs=3 >>>>> total: nonzeros=482400, allocated nonzeros=482400 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> PC Object: (flow_sub_1_) 2 MPI processes >>>>> type: bjacobi >>>>> block Jacobi: number of blocks = 2 >>>>> Local solve is same for all blocks, in the following KSP and PC objects: >>>>> KSP Object: (flow_sub_1_sub_) 1 MPI processes >>>>> type: preonly >>>>> maximum iterations=10000, initial guess is zero >>>>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. <------ not working: -flow_sub_1_sub_ksp_rtol 1e-7 >>>>> left preconditioning >>>>> using NONE norm type for convergence test >>>>> PC Object: (flow_sub_1_sub_) 1 MPI processes >>>>> type: lu >>>>> out-of-place factorization >>>>> tolerance for zero pivot 2.22045e-14 >>>>> matrix ordering: nd >>>>> factor fill ratio given 5., needed 18.3108 >>>>> Factored matrix follows: >>>>> Mat Object: 1 MPI processes >>>>> type: seqbaij >>>>> rows=12000, cols=12000, bs=3 >>>>> package used to perform factorization: petsc >>>>> total: nonzeros=4350654, allocated nonzeros=4350654 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> block size is 3 >>>>> linear system matrix = precond matrix: >>>>> Mat Object: (flow_) 1 MPI processes >>>>> type: seqbaij >>>>> rows=12000, cols=12000, bs=3 >>>>> total: nonzeros=237600, allocated nonzeros=237600 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> block size is 3 >>>>> linear system matrix = precond matrix: >>>>> Mat Object: (flow_) 2 MPI processes >>>>> type: mpibaij >>>>> rows=24000, cols=24000, bs=3 >>>>> total: nonzeros=482400, allocated nonzeros=482400 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> --------------------------------- >>>>> linear system matrix = precond matrix: >>>>> Mat Object: (flow_) 2 MPI processes >>>>> type: mpibaij >>>>> rows=24000, cols=24000, bs=3 >>>>> total: nonzeros=482400, allocated nonzeros=482400 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> >>>>> >>> >>> > > From robert.annewandter at opengosim.com Fri Jul 7 13:48:02 2017 From: robert.annewandter at opengosim.com (Robert Annewandter) Date: Fri, 7 Jul 2017 19:48:02 +0100 Subject: [petsc-users] CPR-AMG: SNES with two cores worse than with one In-Reply-To: References: <293da4be-1eaa-9ac0-54fe-171832a5b4af@opengosim.com> <981f495d-529c-88be-bdaa-4db736e7f357@opengosim.com> Message-ID: Attached the PFLOTRAN default run (KSPBCGS + PCBJacobi + PCILU) for the same input file. NP 1 FLOW TS BE steps = 43 newton = 43 linear = 3950 cuts = 0 FLOW TS BE Wasted Linear Iterations = 0 FLOW TS BE SNES time = 27.6 seconds NP 2 FLOW TS BE steps = 43 newton = 43 linear = 4585 cuts = 0 FLOW TS BE Wasted Linear Iterations = 0 FLOW TS BE SNES time = 21.5 seconds Based on your idea to fix all knobs but one I did a direct solve test on all the PC and KSP's within the SNES I'm using. Simply put my SNES looks like this: SNES - LS: basic - KSP: FGMRES - PC: Composite, multiplicative - PC: Galerkin - KSP: GMRES - PC: Hypre BoomerAMG - SetRestriction: user-defined - SetComputeSubMatrix: user-defined - SetInterpolation: User-defined - PC: BJacobi - KSP: Preonly - PC: LU I want to test direct solves on both PCComposite branches sub 0 and sub 1 and without PCGalerkin (2 tests), and then include PCGalerkin (2 tests), with a final test emulating the Two Stage PC to also stress the user-defined functions in PCGalerkin by doing a double direct solve (1 test, pressure solve first, than whole system with the hyperbolic component included). Long story short: Most tests require 43 Newton and Linear Steps. The last test shows problematic behaviour, and consumes all my memory including swap (16 GB + 16 GB). I can recall an issue with automatically generated Fortran callback (?) for ComputeSubMatrix() issue Matt was mentioning a long while ago.. *Test 2 (Check PCComposite Sub 0)* mpirun \ -n ${NP} pflotran \ -pflotranin ${INPUTFILE}.pflinput \ -flow_ksp_type preonly \ -flow_sub_0_pc_type bjacobi \ -flow_sub_0_sub_pc_type lu \ -flow_sub_0_sub_pc_factor_ nonzeros_along_diagonal \ -flow_sub_1_pc_type none \ -snes_monitor \ -log_view \ 2>&1 > ${OUTPUTFILE}_test_2.log | tee -a ${OUTPUTFILE}_test_2.log NP 1 FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 FLOW TS BE Wasted Linear Iterations = 0 FLOW TS BE SNES time = 215.2 seconds NP 2 FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 FLOW TS BE Wasted Linear Iterations = 0 FLOW TS BE SNES time = 53.7 seconds OK *Test 3 (Check PCComposite Sub 1)* mpirun \ -n ${NP} pflotran \ -pflotranin ${INPUTFILE}.pflinput \ -flow_ksp_type preonly \ -flow_sub_0_pc_type none \ -flow_sub_1_pc_type bjacobi \ -flow_sub_1_sub_pc_type lu \ -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ -snes_monitor \ -log_view \ 2>&1 > ${OUTPUTFILE}_test_3.log | tee -a ${OUTPUTFILE}_test_3.log NP 1 FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 FLOW TS BE Wasted Linear Iterations = 0 FLOW TS BE SNES time = 195.3 seconds NP 2 FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 FLOW TS BE Wasted Linear Iterations = 0 FLOW TS BE SNES time = 53.1 seconds OK *Test 4 (Check PCComposite Sub 1 with empty PCGalerkin on Sub 0)* mpirun \ -n ${NP} pflotran \ -pflotranin ${INPUTFILE}.pflinput \ -flow_ksp_type preonly \ -flow_sub_0_galerkin_ksp_type preonly \ -flow_sub_0_galerkin_pc_type none \ -flow_sub_1_pc_type bjacobi \ -flow_sub_1_sub_pc_type lu \ -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ -snes_monitor \ -log_view \ 2>&1 > ${OUTPUTFILE}_test_4.log | tee -a ${OUTPUTFILE}_test_4.log NP 1 FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 FLOW TS BE Wasted Linear Iterations = 0 FLOW TS BE SNES time = 201.0 seconds NP2 FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 FLOW TS BE Wasted Linear Iterations = 0 FLOW TS BE SNES time = 61.1 seconds OK *Test 5 (Check **PCComposite**Sub 0 with populated PCGalerkin on Sub 0)* mpirun \ -n ${NP} pflotran \ -pflotranin ${INPUTFILE}.pflinput \ -flow_ksp_type preonly \ -flow_sub_0_galerkin_ksp_type preonly \ -flow_sub_0_galerkin_pc_type bjacobi \ -flow_sub_0_galerkin_sub_pc_type lu \ -flow_sub_0_galerkin_sub_pc_factor_nonzeros_along_diagonal \ -flow_sub_1_ksp_type preonly \ -flow_sub_1_pc_type none \ -snes_monitor \ -log_view \ 2>&1 > ${OUTPUTFILE}_test_5.log | tee -a ${OUTPUTFILE}_test_5.log NP 1 FLOW TS BE steps = 142 newton = 294 linear = 294 cuts = 19 FLOW TS BE Wasted Linear Iterations = 152 FLOW TS BE SNES time = 291.5 seconds NP 2 FLOW TS BE steps = 118 newton = 238 linear = 238 cuts = 15 FLOW TS BE Wasted Linear Iterations = 120 FLOW TS BE SNES time = 113.4 seconds LU only solves sub problem Ap *Test 6 (Check PCComposite-PCGalerkin interaction)* mpirun \ -n ${NP} pflotran \ -pflotranin ${INPUTFILE}.pflinput \ -flow_ksp_type preonly \ -flow_sub_0_galerkin_ksp_type preonly \ -flow_sub_0_galerkin_pc_type bjacobi \ -flow_sub_0_galerkin_sub_pc_type lu \ -flow_sub_0_galerkin_sub_pc_factor_nonzeros_along_diagonal \ -flow_sub_1_ksp_type preonly \ -flow_sub_1_pc_type bjacobi \ -flow_sub_1_sub_pc_type lu \ -flow_sub_1_sub_pc_type bjacobi \ -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ -snes_monitor \ -log_view \ 2>&1 > ${OUTPUTFILE}_test_6.log | tee -a ${OUTPUTFILE}_test_6.log NP = 1 Step 1236 Time= 5.58118E-01 Dt= 2.97885E-05 [d] snes_conv_reason: 4 newton = 1 [ 3135] linear = 1 [ 3135] cuts = 0 [ 4] --> SNES Linear/Non-Linear Iterations = 1 / 1 --> SNES Residual: 7.849082E-03 9.811352E-07 7.480307E-03 --> max chng: dpl= 3.3471E+03 dpo= 3.3471E+03 dso= 1.5938E-05 dt= 0.0000E+00 Simulation takes forever and is ongoing as of writing. NP = 2 Step 950 Time= 4.45196E-01 Dt= 1.14579E-04 [d] snes_conv_reason: 4 newton = 3 [ 3217] linear = 3 [ 3217] cuts = 0 [ 0] --> SNES Linear/Non-Linear Iterations = 3 / 3 --> SNES Residual: 2.777416E-02 3.471770E-06 1.976402E-02 --> max chng: dpl= 9.3491E+02 dpo= 9.3491E+02 dso= 5.8911E-05 dt= 0.0000E+00 == TOIL_IMS FLOW ================================================================ 0 SNES Function norm 2.830927483272e-02 0 2r: 2.83E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 1.98E-02 iu: 0.00E+00 rsn: 0 =================================================================================== = BAD TERMINATION OF ONE OF YOUR APPLICATION PROCESSES = PID 586 RUNNING AT mother = EXIT CODE: 9 = CLEANING UP REMAINING PROCESSES = YOU CAN IGNORE THE BELOW CLEANUP MESSAGES =================================================================================== YOUR APPLICATION TERMINATED WITH THE EXIT STRING: Killed (signal 9) This typically refers to a problem with your application. Please see the FAQ page for debugging suggestions On 07/07/17 17:10, Barry Smith wrote: > I don't have a clue. It looks like the np 2 case just takes a different trajectory that runs into trouble that doesn't happen to np 1. Since the linear solves give very good convergence for both np 2 and np 1 I don't think the preconditioner is really the "problem". > > I absolutely do not like the fact that the code is not using a line search. If you look at even the sequential case SNES is sometimes stopping due to snorm even though the function norm has actually increased. Frankly I'm very suspicious of the "solution" of the time integration, it is too much "hit the engine a few times with the hammer until it does what it wants" engineering. > > What happens if you run the 1 and 2 process case with the "default" Pflotran linear solver? > > >> On Jul 7, 2017, at 6:05 AM, Robert Annewandter wrote: >> >> Yes indeed, PFLOTRAN cuts timestep after 8 failed iterations of SNES. >> >> I've rerun with -snes_monitor (attached with canonical suffix), their -pc_type is always PCBJACOBI + PCLU (though we'd like to try SUPERLU in the future, however it works only with -mat_type aij..) >> >> >> The sequential and parallel runs I did with >> >> -ksp_type preonly -pc_type lu -pc_factor_nonzeros_along_diagonal -snes_monitor >> >> and >> >> -ksp_type preonly -pc_type bjacobi -sub_pc_type lu -sub_pc_factor_nonzeros_along_diagonal -snes_monitor >> >> As expected, the sequential are bot identical and the parallel takes half the time compared to sequential. >> >> >> >> >> On 07/07/17 01:20, Barry Smith wrote: >>> Looks like PFLOTRAN has a maximum number of SNES iterations as 8 and cuts the timestep if that fails. >>> >>> Please run with -snes_monitor I don't understand the strange densely packed information that PFLOTRAN is printing. >>> >>> It looks like the linear solver is converging fine in parallel, normally then there is absolutely no reason that the Newton should behave different on 2 processors than 1 unless there is something wrong with the Jacobian. What is the -pc_type for the two cases LU or your fancy thing? >>> >>> Please run sequential and parallel with -pc_type lu and also with -snes_monitor. We need to fix all the knobs but one in order to understand what is going on. >>> >>> >>> Barry >>> >>> >>> >>> >>>> On Jul 6, 2017, at 5:11 PM, Robert Annewandter >>>> wrote: >>>> >>>> Thanks Barry! >>>> >>>> I've attached log files for np = 1 (SNES time: 218 s) and np = 2 (SNES time: 600 s). PFLOTRAN final output: >>>> >>>> NP 1 >>>> >>>> FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 >>>> FLOW TS BE Wasted Linear Iterations = 0 >>>> FLOW TS BE SNES time = 218.9 seconds >>>> >>>> NP 2 >>>> >>>> FLOW TS BE steps = 67 newton = 176 linear = 314 cuts = 13 >>>> FLOW TS BE Wasted Linear Iterations = 208 >>>> FLOW TS BE SNES time = 600.0 seconds >>>> >>>> >>>> Robert >>>> >>>> On 06/07/17 21:24, Barry Smith wrote: >>>> >>>>> So on one process the outer linear solver takes a single iteration this is because the block Jacobi with LU and one block is a direct solver. >>>>> >>>>> >>>>> >>>>>> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >>>>>> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 >>>>>> >>>>>> >>>>> On two processes the outer linear solver takes a few iterations to solver, this is to be expected. >>>>> >>>>> But what you sent doesn't give any indication about SNES not converging. Please turn off all inner linear solver monitoring and just run with -ksp_monitor_true_residual -snes_monitor -snes_lineseach_monitor -snes_converged_reason >>>>> >>>>> Barry >>>>> >>>>> >>>>> >>>>> >>>>> >>>>>> On Jul 6, 2017, at 2:03 PM, Robert Annewandter >>>>>> >>>>>> wrote: >>>>>> >>>>>> Hi all, >>>>>> >>>>>> I like to understand why the SNES of my CPR-AMG Two-Stage Preconditioner (with KSPFGMRES + multipl. PCComposite (PCGalerkin with KSPGMRES + BoomerAMG, PCBJacobi + PCLU init) on a 24,000 x 24,000 matrix) struggles to converge when using two cores instead of one. Because of the adaptive time stepping of the Newton, this leads to severe cuts in time step. >>>>>> >>>>>> This is how I run it with two cores >>>>>> >>>>>> mpirun \ >>>>>> -n 2 pflotran \ >>>>>> -pflotranin het.pflinput \ >>>>>> -ksp_monitor_true_residual \ >>>>>> -flow_snes_view \ >>>>>> -flow_snes_converged_reason \ >>>>>> -flow_sub_1_pc_type bjacobi \ >>>>>> -flow_sub_1_sub_pc_type lu \ >>>>>> -flow_sub_1_sub_pc_factor_pivot_in_blocks true\ >>>>>> -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ >>>>>> -options_left \ >>>>>> -log_summary \ >>>>>> -info >>>>>> >>>>>> >>>>>> With one core I get (after grepping the crap away from -info): >>>>>> >>>>>> Step 32 Time= 1.80000E+01 >>>>>> >>>>>> [...] >>>>>> >>>>>> 0 2r: 1.58E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 7.18E-03 iu: 0.00E+00 rsn: 0 >>>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>>> Residual norms for flow_ solve. >>>>>> 0 KSP unpreconditioned resid norm 1.581814306485e-02 true resid norm 1.581814306485e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>>> 0 KSP preconditioned resid norm 5.697603110484e+07 true resid norm 5.175721849125e+03 ||r(i)||/||b|| 5.037527476892e+03 >>>>>> 1 KSP preconditioned resid norm 5.041509073319e+06 true resid norm 3.251596928176e+02 ||r(i)||/||b|| 3.164777657484e+02 >>>>>> 2 KSP preconditioned resid norm 1.043761838360e+06 true resid norm 8.957519558348e+01 ||r(i)||/||b|| 8.718349288342e+01 >>>>>> 3 KSP preconditioned resid norm 1.129189815646e+05 true resid norm 2.722436912053e+00 ||r(i)||/||b|| 2.649746479496e+00 >>>>>> 4 KSP preconditioned resid norm 8.829637298082e+04 true resid norm 8.026373593492e+00 ||r(i)||/||b|| 7.812065388300e+00 >>>>>> 5 KSP preconditioned resid norm 6.506021637694e+04 true resid norm 3.479889319880e+00 ||r(i)||/||b|| 3.386974527698e+00 >>>>>> 6 KSP preconditioned resid norm 6.392263200180e+04 true resid norm 3.819202631980e+00 ||r(i)||/||b|| 3.717228003987e+00 >>>>>> 7 KSP preconditioned resid norm 2.464946645480e+04 true resid norm 7.329964753388e-01 ||r(i)||/||b|| 7.134251013911e-01 >>>>>> 8 KSP preconditioned resid norm 2.603879153772e+03 true resid norm 2.035525412004e-02 ||r(i)||/||b|| 1.981175861414e-02 >>>>>> 9 KSP preconditioned resid norm 1.774410462754e+02 true resid norm 3.001214973121e-03 ||r(i)||/||b|| 2.921081026352e-03 >>>>>> 10 KSP preconditioned resid norm 1.664227038378e+01 true resid norm 3.413136309181e-04 ||r(i)||/||b|| 3.322003855903e-04 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 1.131868956745e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 2.067297386780e+07 at iteration 11 >>>>>> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >>>>>> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 >>>>>> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=1 >>>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 3.590873180642e-01 near zero implies inconsistent rhs >>>>>> [0] SNESSolve_NEWTONLS(): fnorm=1.5818143064846742e-02, gnorm=1.0695649833687331e-02, ynorm=4.6826522561266171e+02, lssucceed=0 >>>>>> [0] SNESConvergedDefault(): Converged due to small update length: 4.682652256127e+02 < 1.000000000000e-05 * 3.702480426117e+09 >>>>>> 1 2r: 1.07E-02 2x: 3.70E+09 2u: 4.68E+02 ir: 5.05E-03 iu: 4.77E+01 rsn: stol >>>>>> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 >>>>>> >>>>>> >>>>>> >>>>>> But with two cores I get: >>>>>> >>>>>> >>>>>> Step 32 Time= 1.80000E+01 >>>>>> >>>>>> [...] >>>>>> >>>>>> 0 2r: 6.16E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 3.63E-03 iu: 0.00E+00 rsn: 0 >>>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>>> >>>>>> Residual norms for flow_ solve. >>>>>> 0 KSP unpreconditioned resid norm 6.162760088924e-03 true resid norm 6.162760088924e-03 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>>> 0 KSP preconditioned resid norm 8.994949630499e+08 true resid norm 7.982144380936e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> 1 KSP preconditioned resid norm 8.950556502615e+08 true resid norm 1.550138696155e+00 ||r(i)||/||b|| 1.942007839218e+00 >>>>>> 2 KSP preconditioned resid norm 1.044849684205e+08 true resid norm 2.166193480531e+00 ||r(i)||/||b|| 2.713798920631e+00 >>>>>> 3 KSP preconditioned resid norm 8.209708619718e+06 true resid norm 3.076045005154e-01 ||r(i)||/||b|| 3.853657436340e-01 >>>>>> 4 KSP preconditioned resid norm 3.027461352422e+05 true resid norm 1.207731865714e-02 ||r(i)||/||b|| 1.513041869549e-02 >>>>>> 5 KSP preconditioned resid norm 1.595302164817e+04 true resid norm 4.123713694368e-04 ||r(i)||/||b|| 5.166172769585e-04 >>>>>> 6 KSP preconditioned resid norm 1.898935810797e+03 true resid norm 8.275885058330e-05 ||r(i)||/||b|| 1.036799719897e-04 >>>>>> 7 KSP preconditioned resid norm 1.429881682558e+02 true resid norm 4.751240525466e-06 ||r(i)||/||b|| 5.952335987324e-06 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 8.404003313455e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.994949630499e+08 at iteration 8 >>>>>> 8 KSP preconditioned resid norm 8.404003313455e+00 true resid norm 3.841921844578e-07 ||r(i)||/||b|| 4.813145016211e-07 >>>>>> 1 KSP unpreconditioned resid norm 6.162162548202e-03 true resid norm 6.162162548202e-03 ||r(i)||/||b|| 9.999030400804e-01 >>>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>>> 0 KSP preconditioned resid norm 4.360556381209e+07 true resid norm 1.000000245433e+00 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> 1 KSP preconditioned resid norm 5.385519331932e+06 true resid norm 8.785183939860e-02 ||r(i)||/||b|| 8.785181783689e-02 >>>>>> 2 KSP preconditioned resid norm 4.728931283459e+05 true resid norm 2.008708805316e-02 ||r(i)||/||b|| 2.008708312313e-02 >>>>>> 3 KSP preconditioned resid norm 2.734215698319e+04 true resid norm 6.418720397673e-03 ||r(i)||/||b|| 6.418718822309e-03 >>>>>> 4 KSP preconditioned resid norm 1.002270029334e+04 true resid norm 4.040289515991e-03 ||r(i)||/||b|| 4.040288524372e-03 >>>>>> 5 KSP preconditioned resid norm 1.321280190971e+03 true resid norm 1.023292238313e-04 ||r(i)||/||b|| 1.023291987163e-04 >>>>>> 6 KSP preconditioned resid norm 6.594292964815e+01 true resid norm 1.877106733170e-06 ||r(i)||/||b|| 1.877106272467e-06 >>>>>> 7 KSP preconditioned resid norm 7.816325147216e+00 true resid norm 2.552611664980e-07 ||r(i)||/||b|| 2.552611038486e-07 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.391568446109e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.360556381209e+07 at iteration 8 >>>>>> 8 KSP preconditioned resid norm 6.391568446109e-01 true resid norm 1.680724939670e-08 ||r(i)||/||b|| 1.680724527166e-08 >>>>>> 2 KSP unpreconditioned resid norm 4.328902922753e-07 true resid norm 4.328902922752e-07 ||r(i)||/||b|| 7.024292460341e-05 >>>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>>> 0 KSP preconditioned resid norm 8.794597825780e+08 true resid norm 1.000000094566e+00 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> 1 KSP preconditioned resid norm 8.609906572102e+08 true resid norm 2.965044981249e+00 ||r(i)||/||b|| 2.965044700856e+00 >>>>>> 2 KSP preconditioned resid norm 9.318108989314e+07 true resid norm 1.881262939380e+00 ||r(i)||/||b|| 1.881262761477e+00 >>>>>> 3 KSP preconditioned resid norm 6.908723262483e+06 true resid norm 2.639592490398e-01 ||r(i)||/||b|| 2.639592240782e-01 >>>>>> 4 KSP preconditioned resid norm 2.651677791227e+05 true resid norm 9.736480169584e-03 ||r(i)||/||b|| 9.736479248845e-03 >>>>>> 5 KSP preconditioned resid norm 1.192178471172e+04 true resid norm 3.082839752692e-04 ||r(i)||/||b|| 3.082839461160e-04 >>>>>> 6 KSP preconditioned resid norm 1.492201446262e+03 true resid norm 4.633866284506e-05 ||r(i)||/||b|| 4.633865846301e-05 >>>>>> 7 KSP preconditioned resid norm 1.160670017241e+02 true resid norm 2.821157348522e-06 ||r(i)||/||b|| 2.821157081737e-06 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.447568262216e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.794597825780e+08 at iteration 8 >>>>>> 8 KSP preconditioned resid norm 6.447568262216e+00 true resid norm 1.516068561348e-07 ||r(i)||/||b|| 1.516068417980e-07 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.135731709822e-15 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.162760088924e-03 at iteration 3 >>>>>> 3 KSP unpreconditioned resid norm 6.135731709822e-15 true resid norm 1.142020328809e-14 ||r(i)||/||b|| 1.853098793933e-12 >>>>>> >>>>>> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=3 >>>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 1.998388224666e-02 near zero implies inconsistent rhs >>>>>> [0] SNESSolve_NEWTONLS(): fnorm=6.1627600889243711e-03, gnorm=1.0406503258190572e-02, ynorm=6.2999025681245366e+04, lssucceed=0 >>>>>> 1 2r: 1.04E-02 2x: 3.70E+09 2u: 6.30E+04 ir: 6.54E-03 iu: 5.00E+04 rsn: 0 >>>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>>> >>>>>> Residual norms for flow_ solve. >>>>>> 0 KSP unpreconditioned resid norm 1.040650325819e-02 true resid norm 1.040650325819e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>>> 0 KSP preconditioned resid norm 6.758906811264e+07 true resid norm 9.814998431686e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> 1 KSP preconditioned resid norm 2.503922806424e+06 true resid norm 2.275130113021e-01 ||r(i)||/||b|| 2.318013730574e-01 >>>>>> 2 KSP preconditioned resid norm 3.316753614870e+05 true resid norm 3.820733530238e-02 ||r(i)||/||b|| 3.892750016040e-02 >>>>>> 3 KSP preconditioned resid norm 2.956751700483e+04 true resid norm 2.143772538677e-03 ||r(i)||/||b|| 2.184180215207e-03 >>>>>> 4 KSP preconditioned resid norm 1.277067042524e+03 true resid norm 9.093614251311e-05 ||r(i)||/||b|| 9.265018547485e-05 >>>>>> 5 KSP preconditioned resid norm 1.060996002446e+02 true resid norm 1.042893700050e-05 ||r(i)||/||b|| 1.062551061326e-05 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 5.058127343285e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.758906811264e+07 at iteration 6 >>>>>> 6 KSP preconditioned resid norm 5.058127343285e+00 true resid norm 4.054770602120e-07 ||r(i)||/||b|| 4.131198420807e-07 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.449606189225e-10 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.040650325819e-02 at iteration 1 >>>>>> 1 KSP unpreconditioned resid norm 4.449606189225e-10 true resid norm 4.449606189353e-10 ||r(i)||/||b|| 4.275793779098e-08 >>>>>> >>>>>> [0] SNESSolve_NEWTONLS(): iter=1, linear solve iterations=1 >>>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.300066663571e-02 near zero implies inconsistent rhs >>>>>> [0] SNESSolve_NEWTONLS(): fnorm=1.0406503258190572e-02, gnorm=7.3566280848133728e-02, ynorm=7.9500485128639993e+04, lssucceed=0 >>>>>> 2 2r: 7.36E-02 2x: 3.70E+09 2u: 7.95E+04 ir: 4.62E-02 iu: 5.00E+04 rsn: 0 >>>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>>> >>>>>> Residual norms for flow_ solve. >>>>>> 0 KSP unpreconditioned resid norm 7.356628084813e-02 true resid norm 7.356628084813e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>>> 0 KSP preconditioned resid norm 7.253424029194e+06 true resid norm 9.647008645250e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> 1 KSP preconditioned resid norm 7.126940190688e+06 true resid norm 1.228009197928e+00 ||r(i)||/||b|| 1.272942984800e+00 >>>>>> 2 KSP preconditioned resid norm 9.391591432635e+05 true resid norm 7.804929162756e-01 ||r(i)||/||b|| 8.090517433711e-01 >>>>>> 3 KSP preconditioned resid norm 6.538499674761e+04 true resid norm 5.503467432893e-02 ||r(i)||/||b|| 5.704843475602e-02 >>>>>> 4 KSP preconditioned resid norm 1.593713396575e+04 true resid norm 8.902701363763e-02 ||r(i)||/||b|| 9.228457951208e-02 >>>>>> 5 KSP preconditioned resid norm 4.837260621464e+02 true resid norm 2.966772992825e-03 ||r(i)||/||b|| 3.075329464213e-03 >>>>>> 6 KSP preconditioned resid norm 1.681372767335e+02 true resid norm 5.312467443025e-04 ||r(i)||/||b|| 5.506854651406e-04 >>>>>> 7 KSP preconditioned resid norm 1.271478850717e+01 true resid norm 2.123810020488e-05 ||r(i)||/||b|| 2.201521838103e-05 >>>>>> 8 KSP preconditioned resid norm 1.262723712696e+00 true resid norm 1.150572715331e-06 ||r(i)||/||b|| 1.192673042641e-06 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 9.053072585125e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.253424029194e+06 at iteration 9 >>>>>> 9 KSP preconditioned resid norm 9.053072585125e-02 true resid norm 9.475050575058e-08 ||r(i)||/||b|| 9.821749853747e-08 >>>>>> 1 KSP unpreconditioned resid norm 8.171589173162e-03 true resid norm 8.171589173162e-03 ||r(i)||/||b|| 1.110779161180e-01 >>>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>>> 0 KSP preconditioned resid norm 4.345765068989e+07 true resid norm 9.999992231691e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> 1 KSP preconditioned resid norm 5.388715093466e+06 true resid norm 8.125387327699e-02 ||r(i)||/||b|| 8.125393639755e-02 >>>>>> 2 KSP preconditioned resid norm 4.763725726436e+05 true resid norm 2.464285618036e-02 ||r(i)||/||b|| 2.464287532371e-02 >>>>>> 3 KSP preconditioned resid norm 2.287746683380e+04 true resid norm 7.224823080100e-03 ||r(i)||/||b|| 7.224828692570e-03 >>>>>> 4 KSP preconditioned resid norm 4.872858764091e+03 true resid norm 3.972261388893e-03 ||r(i)||/||b|| 3.972264474670e-03 >>>>>> 5 KSP preconditioned resid norm 8.670449895323e+02 true resid norm 2.359005963873e-04 ||r(i)||/||b|| 2.359007796423e-04 >>>>>> 6 KSP preconditioned resid norm 4.252589693890e+01 true resid norm 1.471904261226e-06 ||r(i)||/||b|| 1.471905404648e-06 >>>>>> 7 KSP preconditioned resid norm 5.128476471782e+00 true resid norm 1.643725157865e-07 ||r(i)||/||b|| 1.643726434763e-07 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.311901915856e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.345765068989e+07 at iteration 8 >>>>>> 8 KSP preconditioned resid norm 4.311901915856e-01 true resid norm 1.166123921637e-08 ||r(i)||/||b|| 1.166124827519e-08 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.373662391739e-09 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.356628084813e-02 at iteration 2 >>>>>> 2 KSP unpreconditioned resid norm 2.373662391739e-09 true resid norm 2.373662391658e-09 ||r(i)||/||b|| 3.226562990941e-08 >>>>>> >>>>>> [0] SNESSolve_NEWTONLS(): iter=2, linear solve iterations=2 >>>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.343326231305e-02 near zero implies inconsistent rhs >>>>>> [0] SNESSolve_NEWTONLS(): fnorm=7.3566280848133728e-02, gnorm=7.2259942496422647e-02, ynorm=6.3156901950486099e+04, lssucceed=0 >>>>>> 3 2r: 7.23E-02 2x: 3.70E+09 2u: 6.32E+04 ir: 4.52E-02 iu: 5.00E+04 rsn: 0 >>>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>>> >>>>>> Residual norms for flow_ solve. >>>>>> 0 KSP unpreconditioned resid norm 7.225994249642e-02 true resid norm 7.225994249642e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>>> 0 KSP preconditioned resid norm 7.705582590638e+05 true resid norm 9.649751442741e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>>> 1 KSP preconditioned resid norm 2.444424220392e+04 true resid norm 8.243110200738e-03 ||r(i)||/||b|| 8.542303135630e-03 >>>>>> 2 KSP preconditioned resid norm 2.080899648412e+03 true resid norm 7.642343147053e-04 ||r(i)||/||b|| 7.919730567570e-04 >>>>>> 3 KSP preconditioned resid norm 9.911171129874e+02 true resid norm 5.904182179180e-05 ||r(i)||/||b|| 6.118481096859e-05 >>>>>> 4 KSP preconditioned resid norm 5.258230282482e+02 true resid norm 2.043366677644e-04 ||r(i)||/||b|| 2.117532964210e-04 >>>>>> 5 KSP preconditioned resid norm 5.522830460456e+01 true resid norm 1.710780366056e-05 ||r(i)||/||b|| 1.772875059225e-05 >>>>>> 6 KSP preconditioned resid norm 5.922280741715e+00 true resid norm 1.543198740828e-06 ||r(i)||/||b|| 1.599210870855e-06 >>>>>> 7 KSP preconditioned resid norm 3.339500859115e-01 true resid norm 1.221335666427e-07 ||r(i)||/||b|| 1.265665414984e-07 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 3.329208597672e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.705582590638e+05 at iteration 8 >>>>>> 8 KSP preconditioned resid norm 3.329208597672e-02 true resid norm 9.758240835324e-09 ||r(i)||/||b|| 1.011242713683e-08 >>>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.697128456432e-11 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.225994249642e-02 at iteration 1 >>>>>> 1 KSP unpreconditioned resid norm 2.697128456432e-11 true resid norm 2.697128457142e-11 ||r(i)||/||b|| 3.732536124389e-10 >>>>>> >>>>>> [0] SNESSolve_NEWTONLS(): iter=3, linear solve iterations=1 >>>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.329227684222e-02 near zero implies inconsistent rhs >>>>>> [0] SNESSolve_NEWTONLS(): fnorm=7.2259942496422647e-02, gnorm=5.4435602192925014e-01, ynorm=2.7049750229137400e+04, lssucceed=0 >>>>>> [0] SNESConvergedDefault(): Converged due to small update length: 2.704975022914e+04 < 1.000000000000e-05 * 3.702469482296e+09 >>>>>> 4 2r: 5.44E-01 2x: 3.70E+09 2u: 2.70E+04 ir: 3.84E-01 iu: 2.34E+04 rsn: stol >>>>>> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 4 >>>>>> >>>>>> >>>>>> As the simulation advances this behaviour leads to frequent time step cuts because of 8 subsequently failed Newton iterations, which brings the simulation practically to a halt. >>>>>> >>>>>> Is the Block Jacobi not a good choice? Better ASM with huge overlap? Or is there something wrong with my RHS? Maybe the SNES, SNESLS, KSP tolerances need better tuning? >>>>>> >>>>>> Grateful for any clarifying words! >>>>>> Robert >>>>>> >>>>>> >>>>>> My SNES_view is: >>>>>> >>>>>> >>>>>> SNES Object: (flow_) 2 MPI processes >>>>>> type: newtonls >>>>>> maximum iterations=8, maximum function evaluations=10000 >>>>>> tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 >>>>>> total number of linear solver iterations=1 >>>>>> total number of function evaluations=2 >>>>>> norm schedule ALWAYS >>>>>> SNESLineSearch Object: (flow_) 2 MPI processes >>>>>> type: basic >>>>>> maxstep=1.000000e+08, minlambda=1.000000e-05 >>>>>> tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 >>>>>> maximum iterations=40 >>>>>> using user-defined precheck step >>>>>> KSP Object: (flow_) 2 MPI processes >>>>>> type: fgmres >>>>>> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >>>>>> GMRES: happy breakdown tolerance 1e-30 >>>>>> maximum iterations=200, initial guess is zero >>>>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>>>> right preconditioning >>>>>> using UNPRECONDITIONED norm type for convergence test >>>>>> PC Object: (flow_) 2 MPI processes >>>>>> type: composite >>>>>> Composite PC type - MULTIPLICATIVE >>>>>> PCs on composite preconditioner follow >>>>>> --------------------------------- >>>>>> PC Object: (flow_sub_0_) 2 MPI processes >>>>>> type: galerkin >>>>>> Galerkin PC >>>>>> KSP on Galerkin follow >>>>>> --------------------------------- >>>>>> KSP Object: (flow_sub_0_galerkin_) 2 MPI processes >>>>>> type: gmres >>>>>> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >>>>>> GMRES: happy breakdown tolerance 1e-30 >>>>>> maximum iterations=200, initial guess is zero >>>>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>>>> left preconditioning >>>>>> using PRECONDITIONED norm type for convergence test >>>>>> PC Object: (flow_sub_0_galerkin_) 2 MPI processes >>>>>> type: hypre >>>>>> HYPRE BoomerAMG preconditioning >>>>>> HYPRE BoomerAMG: Cycle type V >>>>>> HYPRE BoomerAMG: Maximum number of levels 25 >>>>>> HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 >>>>>> HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. >>>>>> HYPRE BoomerAMG: Threshold for strong coupling 0.25 >>>>>> HYPRE BoomerAMG: Interpolation truncation factor 0. >>>>>> HYPRE BoomerAMG: Interpolation: max elements per row 0 >>>>>> HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 >>>>>> HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 >>>>>> HYPRE BoomerAMG: Maximum row sums 0.9 >>>>>> HYPRE BoomerAMG: Sweeps down 1 >>>>>> HYPRE BoomerAMG: Sweeps up 1 >>>>>> HYPRE BoomerAMG: Sweeps on coarse 1 >>>>>> HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi >>>>>> HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi >>>>>> HYPRE BoomerAMG: Relax on coarse Gaussian-elimination >>>>>> HYPRE BoomerAMG: Relax weight (all) 1. >>>>>> HYPRE BoomerAMG: Outer relax weight (all) 1. >>>>>> HYPRE BoomerAMG: Using CF-relaxation >>>>>> HYPRE BoomerAMG: Not using more complex smoothers. >>>>>> HYPRE BoomerAMG: Measure type local >>>>>> HYPRE BoomerAMG: Coarsen type Falgout >>>>>> HYPRE BoomerAMG: Interpolation type classical >>>>>> linear system matrix = precond matrix: >>>>>> Mat Object: 2 MPI processes >>>>>> type: mpiaij >>>>>> rows=8000, cols=8000 >>>>>> total: nonzeros=53600, allocated nonzeros=53600 >>>>>> total number of mallocs used during MatSetValues calls =0 >>>>>> not using I-node (on process 0) routines >>>>>> linear system matrix = precond matrix: >>>>>> Mat Object: (flow_) 2 MPI processes >>>>>> type: mpibaij >>>>>> rows=24000, cols=24000, bs=3 >>>>>> total: nonzeros=482400, allocated nonzeros=482400 >>>>>> total number of mallocs used during MatSetValues calls =0 >>>>>> PC Object: (flow_sub_1_) 2 MPI processes >>>>>> type: bjacobi >>>>>> block Jacobi: number of blocks = 2 >>>>>> Local solve is same for all blocks, in the following KSP and PC objects: >>>>>> KSP Object: (flow_sub_1_sub_) 1 MPI processes >>>>>> type: preonly >>>>>> maximum iterations=10000, initial guess is zero >>>>>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. <------ not working: -flow_sub_1_sub_ksp_rtol 1e-7 >>>>>> left preconditioning >>>>>> using NONE norm type for convergence test >>>>>> PC Object: (flow_sub_1_sub_) 1 MPI processes >>>>>> type: lu >>>>>> out-of-place factorization >>>>>> tolerance for zero pivot 2.22045e-14 >>>>>> matrix ordering: nd >>>>>> factor fill ratio given 5., needed 18.3108 >>>>>> Factored matrix follows: >>>>>> Mat Object: 1 MPI processes >>>>>> type: seqbaij >>>>>> rows=12000, cols=12000, bs=3 >>>>>> package used to perform factorization: petsc >>>>>> total: nonzeros=4350654, allocated nonzeros=4350654 >>>>>> total number of mallocs used during MatSetValues calls =0 >>>>>> block size is 3 >>>>>> linear system matrix = precond matrix: >>>>>> Mat Object: (flow_) 1 MPI processes >>>>>> type: seqbaij >>>>>> rows=12000, cols=12000, bs=3 >>>>>> total: nonzeros=237600, allocated nonzeros=237600 >>>>>> total number of mallocs used during MatSetValues calls =0 >>>>>> block size is 3 >>>>>> linear system matrix = precond matrix: >>>>>> Mat Object: (flow_) 2 MPI processes >>>>>> type: mpibaij >>>>>> rows=24000, cols=24000, bs=3 >>>>>> total: nonzeros=482400, allocated nonzeros=482400 >>>>>> total number of mallocs used during MatSetValues calls =0 >>>>>> --------------------------------- >>>>>> linear system matrix = precond matrix: >>>>>> Mat Object: (flow_) 2 MPI processes >>>>>> type: mpibaij >>>>>> rows=24000, cols=24000, bs=3 >>>>>> total: nonzeros=482400, allocated nonzeros=482400 >>>>>> total number of mallocs used during MatSetValues calls =0 >>>>>> >>>>>> >>>> >>>> >> -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: het_np_1_default.log Type: text/x-log Size: 37690 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: het_np_2_default.log Type: text/x-log Size: 38129 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: Check_SNES_KSP_PC_Tree.tar.gz Type: application/gzip Size: 644829 bytes Desc: not available URL: From robert.annewandter at opengosim.com Fri Jul 7 15:11:25 2017 From: robert.annewandter at opengosim.com (Robert Annewandter) Date: Fri, 7 Jul 2017 21:11:25 +0100 Subject: [petsc-users] CPR-AMG: SNES with two cores worse than with one In-Reply-To: References: <293da4be-1eaa-9ac0-54fe-171832a5b4af@opengosim.com> <981f495d-529c-88be-bdaa-4db736e7f357@opengosim.com> Message-ID: Thank you Hong! I've used GMRES via mpirun \ -n ${NP} pflotran \ -pflotranin ${INPUTFILE}.pflinput \ -flow_ksp_type gmres \ -flow_pc_type bjacobi \ -flow_sub_pc_type lu \ -flow_sub_pc_factor_nonzeros_along_diagonal \ -snes_monitor and get: NP 1 FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 FLOW TS BE Wasted Linear Iterations = 0 FLOW TS BE SNES time = 197.0 seconds NP 2 FLOW TS BE steps = 43 newton = 43 linear = 770 cuts = 0 FLOW TS BE Wasted Linear Iterations = 0 FLOW TS BE SNES time = 68.7 seconds Which looks ok to me. Robert On 07/07/17 15:49, hong at aspiritech.org wrote: > What do you get with '-ksp_type gmres' or '-ksp_type bcgs' in parallel > runs? > Hong > > On Fri, Jul 7, 2017 at 6:05 AM, Robert Annewandter > > wrote: > > Yes indeed, PFLOTRAN cuts timestep after 8 failed iterations of SNES. > > I've rerun with -snes_monitor (attached with canonical suffix), > their -pc_type is always PCBJACOBI + PCLU (though we'd like to try > SUPERLU in the future, however it works only with -mat_type aij..) > > > The sequential and parallel runs I did with > > -ksp_type preonly -pc_type lu > -pc_factor_nonzeros_along_diagonal -snes_monitor > > and > > -ksp_type preonly -pc_type bjacobi -sub_pc_type lu > -sub_pc_factor_nonzeros_along_diagonal -snes_monitor > > As expected, the sequential are bot identical and the parallel > takes half the time compared to sequential. > > > > > On 07/07/17 01:20, Barry Smith wrote: >> Looks like PFLOTRAN has a maximum number of SNES iterations as 8 and cuts the timestep if that fails. >> >> Please run with -snes_monitor I don't understand the strange densely packed information that PFLOTRAN is printing. >> >> It looks like the linear solver is converging fine in parallel, normally then there is absolutely no reason that the Newton should behave different on 2 processors than 1 unless there is something wrong with the Jacobian. What is the -pc_type for the two cases LU or your fancy thing? >> >> Please run sequential and parallel with -pc_type lu and also with -snes_monitor. We need to fix all the knobs but one in order to understand what is going on. >> >> >> Barry >> >> >> >>> On Jul 6, 2017, at 5:11 PM, Robert Annewandter >>> wrote: >>> >>> Thanks Barry! >>> >>> I've attached log files for np = 1 (SNES time: 218 s) and np = 2 (SNES time: 600 s). PFLOTRAN final output: >>> >>> NP 1 >>> >>> FLOW TS BE steps = 43 newton = 43 linear = 43 cuts = 0 >>> FLOW TS BE Wasted Linear Iterations = 0 >>> FLOW TS BE SNES time = 218.9 seconds >>> >>> NP 2 >>> >>> FLOW TS BE steps = 67 newton = 176 linear = 314 cuts = 13 >>> FLOW TS BE Wasted Linear Iterations = 208 >>> FLOW TS BE SNES time = 600.0 seconds >>> >>> >>> Robert >>> >>> On 06/07/17 21:24, Barry Smith wrote: >>>> So on one process the outer linear solver takes a single iteration this is because the block Jacobi with LU and one block is a direct solver. >>>> >>>> >>>>> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >>>>> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 >>>>> >>>> On two processes the outer linear solver takes a few iterations to solver, this is to be expected. >>>> >>>> But what you sent doesn't give any indication about SNES not converging. Please turn off all inner linear solver monitoring and just run with -ksp_monitor_true_residual -snes_monitor -snes_lineseach_monitor -snes_converged_reason >>>> >>>> Barry >>>> >>>> >>>> >>>> >>>>> On Jul 6, 2017, at 2:03 PM, Robert Annewandter >>>>> >>>>> wrote: >>>>> >>>>> Hi all, >>>>> >>>>> I like to understand why the SNES of my CPR-AMG Two-Stage Preconditioner (with KSPFGMRES + multipl. PCComposite (PCGalerkin with KSPGMRES + BoomerAMG, PCBJacobi + PCLU init) on a 24,000 x 24,000 matrix) struggles to converge when using two cores instead of one. Because of the adaptive time stepping of the Newton, this leads to severe cuts in time step. >>>>> >>>>> This is how I run it with two cores >>>>> >>>>> mpirun \ >>>>> -n 2 pflotran \ >>>>> -pflotranin het.pflinput \ >>>>> -ksp_monitor_true_residual \ >>>>> -flow_snes_view \ >>>>> -flow_snes_converged_reason \ >>>>> -flow_sub_1_pc_type bjacobi \ >>>>> -flow_sub_1_sub_pc_type lu \ >>>>> -flow_sub_1_sub_pc_factor_pivot_in_blocks true\ >>>>> -flow_sub_1_sub_pc_factor_nonzeros_along_diagonal \ >>>>> -options_left \ >>>>> -log_summary \ >>>>> -info >>>>> >>>>> >>>>> With one core I get (after grepping the crap away from -info): >>>>> >>>>> Step 32 Time= 1.80000E+01 >>>>> >>>>> [...] >>>>> >>>>> 0 2r: 1.58E-02 2x: 0.00E+00 2u: 0.00E+00 ir: 7.18E-03 iu: 0.00E+00 rsn: 0 >>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>> Residual norms for flow_ solve. >>>>> 0 KSP unpreconditioned resid norm 1.581814306485e-02 true resid norm 1.581814306485e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 5.697603110484e+07 true resid norm 5.175721849125e+03 ||r(i)||/||b|| 5.037527476892e+03 >>>>> 1 KSP preconditioned resid norm 5.041509073319e+06 true resid norm 3.251596928176e+02 ||r(i)||/||b|| 3.164777657484e+02 >>>>> 2 KSP preconditioned resid norm 1.043761838360e+06 true resid norm 8.957519558348e+01 ||r(i)||/||b|| 8.718349288342e+01 >>>>> 3 KSP preconditioned resid norm 1.129189815646e+05 true resid norm 2.722436912053e+00 ||r(i)||/||b|| 2.649746479496e+00 >>>>> 4 KSP preconditioned resid norm 8.829637298082e+04 true resid norm 8.026373593492e+00 ||r(i)||/||b|| 7.812065388300e+00 >>>>> 5 KSP preconditioned resid norm 6.506021637694e+04 true resid norm 3.479889319880e+00 ||r(i)||/||b|| 3.386974527698e+00 >>>>> 6 KSP preconditioned resid norm 6.392263200180e+04 true resid norm 3.819202631980e+00 ||r(i)||/||b|| 3.717228003987e+00 >>>>> 7 KSP preconditioned resid norm 2.464946645480e+04 true resid norm 7.329964753388e-01 ||r(i)||/||b|| 7.134251013911e-01 >>>>> 8 KSP preconditioned resid norm 2.603879153772e+03 true resid norm 2.035525412004e-02 ||r(i)||/||b|| 1.981175861414e-02 >>>>> 9 KSP preconditioned resid norm 1.774410462754e+02 true resid norm 3.001214973121e-03 ||r(i)||/||b|| 2.921081026352e-03 >>>>> 10 KSP preconditioned resid norm 1.664227038378e+01 true resid norm 3.413136309181e-04 ||r(i)||/||b|| 3.322003855903e-04 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 1.131868956745e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 2.067297386780e+07 at iteration 11 >>>>> 11 KSP preconditioned resid norm 1.131868956745e+00 true resid norm 1.526261825526e-05 ||r(i)||/||b|| 1.485509868409e-05 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.148515820410e-14 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.581814306485e-02 at iteration 1 >>>>> 1 KSP unpreconditioned resid norm 2.148515820410e-14 true resid norm 2.148698024622e-14 ||r(i)||/||b|| 1.358375642332e-12 >>>>> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=1 >>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 3.590873180642e-01 near zero implies inconsistent rhs >>>>> [0] SNESSolve_NEWTONLS(): fnorm=1.5818143064846742e-02, gnorm=1.0695649833687331e-02, ynorm=4.6826522561266171e+02, lssucceed=0 >>>>> [0] SNESConvergedDefault(): Converged due to small update length: 4.682652256127e+02 < 1.000000000000e-05 * 3.702480426117e+09 >>>>> 1 2r: 1.07E-02 2x: 3.70E+09 2u: 4.68E+02 ir: 5.05E-03 iu: 4.77E+01 rsn: stol >>>>> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 1 >>>>> >>>>> >>>>> >>>>> But with two cores I get: >>>>> >>>>> >>>>> Step 32 Time= 1.80000E+01 >>>>> >>>>> [...] >>>>> >>>>> 0 2r: 6.16E-03 2x: 0.00E+00 2u: 0.00E+00 ir: 3.63E-03 iu: 0.00E+00 rsn: 0 >>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>> >>>>> Residual norms for flow_ solve. >>>>> 0 KSP unpreconditioned resid norm 6.162760088924e-03 true resid norm 6.162760088924e-03 ||r(i)||/||b|| 1.000000000000e+00 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 8.994949630499e+08 true resid norm 7.982144380936e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 8.950556502615e+08 true resid norm 1.550138696155e+00 ||r(i)||/||b|| 1.942007839218e+00 >>>>> 2 KSP preconditioned resid norm 1.044849684205e+08 true resid norm 2.166193480531e+00 ||r(i)||/||b|| 2.713798920631e+00 >>>>> 3 KSP preconditioned resid norm 8.209708619718e+06 true resid norm 3.076045005154e-01 ||r(i)||/||b|| 3.853657436340e-01 >>>>> 4 KSP preconditioned resid norm 3.027461352422e+05 true resid norm 1.207731865714e-02 ||r(i)||/||b|| 1.513041869549e-02 >>>>> 5 KSP preconditioned resid norm 1.595302164817e+04 true resid norm 4.123713694368e-04 ||r(i)||/||b|| 5.166172769585e-04 >>>>> 6 KSP preconditioned resid norm 1.898935810797e+03 true resid norm 8.275885058330e-05 ||r(i)||/||b|| 1.036799719897e-04 >>>>> 7 KSP preconditioned resid norm 1.429881682558e+02 true resid norm 4.751240525466e-06 ||r(i)||/||b|| 5.952335987324e-06 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 8.404003313455e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.994949630499e+08 at iteration 8 >>>>> 8 KSP preconditioned resid norm 8.404003313455e+00 true resid norm 3.841921844578e-07 ||r(i)||/||b|| 4.813145016211e-07 >>>>> 1 KSP unpreconditioned resid norm 6.162162548202e-03 true resid norm 6.162162548202e-03 ||r(i)||/||b|| 9.999030400804e-01 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 4.360556381209e+07 true resid norm 1.000000245433e+00 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 5.385519331932e+06 true resid norm 8.785183939860e-02 ||r(i)||/||b|| 8.785181783689e-02 >>>>> 2 KSP preconditioned resid norm 4.728931283459e+05 true resid norm 2.008708805316e-02 ||r(i)||/||b|| 2.008708312313e-02 >>>>> 3 KSP preconditioned resid norm 2.734215698319e+04 true resid norm 6.418720397673e-03 ||r(i)||/||b|| 6.418718822309e-03 >>>>> 4 KSP preconditioned resid norm 1.002270029334e+04 true resid norm 4.040289515991e-03 ||r(i)||/||b|| 4.040288524372e-03 >>>>> 5 KSP preconditioned resid norm 1.321280190971e+03 true resid norm 1.023292238313e-04 ||r(i)||/||b|| 1.023291987163e-04 >>>>> 6 KSP preconditioned resid norm 6.594292964815e+01 true resid norm 1.877106733170e-06 ||r(i)||/||b|| 1.877106272467e-06 >>>>> 7 KSP preconditioned resid norm 7.816325147216e+00 true resid norm 2.552611664980e-07 ||r(i)||/||b|| 2.552611038486e-07 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.391568446109e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.360556381209e+07 at iteration 8 >>>>> 8 KSP preconditioned resid norm 6.391568446109e-01 true resid norm 1.680724939670e-08 ||r(i)||/||b|| 1.680724527166e-08 >>>>> 2 KSP unpreconditioned resid norm 4.328902922753e-07 true resid norm 4.328902922752e-07 ||r(i)||/||b|| 7.024292460341e-05 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 8.794597825780e+08 true resid norm 1.000000094566e+00 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 8.609906572102e+08 true resid norm 2.965044981249e+00 ||r(i)||/||b|| 2.965044700856e+00 >>>>> 2 KSP preconditioned resid norm 9.318108989314e+07 true resid norm 1.881262939380e+00 ||r(i)||/||b|| 1.881262761477e+00 >>>>> 3 KSP preconditioned resid norm 6.908723262483e+06 true resid norm 2.639592490398e-01 ||r(i)||/||b|| 2.639592240782e-01 >>>>> 4 KSP preconditioned resid norm 2.651677791227e+05 true resid norm 9.736480169584e-03 ||r(i)||/||b|| 9.736479248845e-03 >>>>> 5 KSP preconditioned resid norm 1.192178471172e+04 true resid norm 3.082839752692e-04 ||r(i)||/||b|| 3.082839461160e-04 >>>>> 6 KSP preconditioned resid norm 1.492201446262e+03 true resid norm 4.633866284506e-05 ||r(i)||/||b|| 4.633865846301e-05 >>>>> 7 KSP preconditioned resid norm 1.160670017241e+02 true resid norm 2.821157348522e-06 ||r(i)||/||b|| 2.821157081737e-06 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.447568262216e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 8.794597825780e+08 at iteration 8 >>>>> 8 KSP preconditioned resid norm 6.447568262216e+00 true resid norm 1.516068561348e-07 ||r(i)||/||b|| 1.516068417980e-07 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 6.135731709822e-15 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.162760088924e-03 at iteration 3 >>>>> 3 KSP unpreconditioned resid norm 6.135731709822e-15 true resid norm 1.142020328809e-14 ||r(i)||/||b|| 1.853098793933e-12 >>>>> >>>>> [0] SNESSolve_NEWTONLS(): iter=0, linear solve iterations=3 >>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 1.998388224666e-02 near zero implies inconsistent rhs >>>>> [0] SNESSolve_NEWTONLS(): fnorm=6.1627600889243711e-03, gnorm=1.0406503258190572e-02, ynorm=6.2999025681245366e+04, lssucceed=0 >>>>> 1 2r: 1.04E-02 2x: 3.70E+09 2u: 6.30E+04 ir: 6.54E-03 iu: 5.00E+04 rsn: 0 >>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>> >>>>> Residual norms for flow_ solve. >>>>> 0 KSP unpreconditioned resid norm 1.040650325819e-02 true resid norm 1.040650325819e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 6.758906811264e+07 true resid norm 9.814998431686e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 2.503922806424e+06 true resid norm 2.275130113021e-01 ||r(i)||/||b|| 2.318013730574e-01 >>>>> 2 KSP preconditioned resid norm 3.316753614870e+05 true resid norm 3.820733530238e-02 ||r(i)||/||b|| 3.892750016040e-02 >>>>> 3 KSP preconditioned resid norm 2.956751700483e+04 true resid norm 2.143772538677e-03 ||r(i)||/||b|| 2.184180215207e-03 >>>>> 4 KSP preconditioned resid norm 1.277067042524e+03 true resid norm 9.093614251311e-05 ||r(i)||/||b|| 9.265018547485e-05 >>>>> 5 KSP preconditioned resid norm 1.060996002446e+02 true resid norm 1.042893700050e-05 ||r(i)||/||b|| 1.062551061326e-05 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 5.058127343285e+00 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 6.758906811264e+07 at iteration 6 >>>>> 6 KSP preconditioned resid norm 5.058127343285e+00 true resid norm 4.054770602120e-07 ||r(i)||/||b|| 4.131198420807e-07 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.449606189225e-10 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 1.040650325819e-02 at iteration 1 >>>>> 1 KSP unpreconditioned resid norm 4.449606189225e-10 true resid norm 4.449606189353e-10 ||r(i)||/||b|| 4.275793779098e-08 >>>>> >>>>> [0] SNESSolve_NEWTONLS(): iter=1, linear solve iterations=1 >>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.300066663571e-02 near zero implies inconsistent rhs >>>>> [0] SNESSolve_NEWTONLS(): fnorm=1.0406503258190572e-02, gnorm=7.3566280848133728e-02, ynorm=7.9500485128639993e+04, lssucceed=0 >>>>> 2 2r: 7.36E-02 2x: 3.70E+09 2u: 7.95E+04 ir: 4.62E-02 iu: 5.00E+04 rsn: 0 >>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>> >>>>> Residual norms for flow_ solve. >>>>> 0 KSP unpreconditioned resid norm 7.356628084813e-02 true resid norm 7.356628084813e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 7.253424029194e+06 true resid norm 9.647008645250e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 7.126940190688e+06 true resid norm 1.228009197928e+00 ||r(i)||/||b|| 1.272942984800e+00 >>>>> 2 KSP preconditioned resid norm 9.391591432635e+05 true resid norm 7.804929162756e-01 ||r(i)||/||b|| 8.090517433711e-01 >>>>> 3 KSP preconditioned resid norm 6.538499674761e+04 true resid norm 5.503467432893e-02 ||r(i)||/||b|| 5.704843475602e-02 >>>>> 4 KSP preconditioned resid norm 1.593713396575e+04 true resid norm 8.902701363763e-02 ||r(i)||/||b|| 9.228457951208e-02 >>>>> 5 KSP preconditioned resid norm 4.837260621464e+02 true resid norm 2.966772992825e-03 ||r(i)||/||b|| 3.075329464213e-03 >>>>> 6 KSP preconditioned resid norm 1.681372767335e+02 true resid norm 5.312467443025e-04 ||r(i)||/||b|| 5.506854651406e-04 >>>>> 7 KSP preconditioned resid norm 1.271478850717e+01 true resid norm 2.123810020488e-05 ||r(i)||/||b|| 2.201521838103e-05 >>>>> 8 KSP preconditioned resid norm 1.262723712696e+00 true resid norm 1.150572715331e-06 ||r(i)||/||b|| 1.192673042641e-06 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 9.053072585125e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.253424029194e+06 at iteration 9 >>>>> 9 KSP preconditioned resid norm 9.053072585125e-02 true resid norm 9.475050575058e-08 ||r(i)||/||b|| 9.821749853747e-08 >>>>> 1 KSP unpreconditioned resid norm 8.171589173162e-03 true resid norm 8.171589173162e-03 ||r(i)||/||b|| 1.110779161180e-01 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 4.345765068989e+07 true resid norm 9.999992231691e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 5.388715093466e+06 true resid norm 8.125387327699e-02 ||r(i)||/||b|| 8.125393639755e-02 >>>>> 2 KSP preconditioned resid norm 4.763725726436e+05 true resid norm 2.464285618036e-02 ||r(i)||/||b|| 2.464287532371e-02 >>>>> 3 KSP preconditioned resid norm 2.287746683380e+04 true resid norm 7.224823080100e-03 ||r(i)||/||b|| 7.224828692570e-03 >>>>> 4 KSP preconditioned resid norm 4.872858764091e+03 true resid norm 3.972261388893e-03 ||r(i)||/||b|| 3.972264474670e-03 >>>>> 5 KSP preconditioned resid norm 8.670449895323e+02 true resid norm 2.359005963873e-04 ||r(i)||/||b|| 2.359007796423e-04 >>>>> 6 KSP preconditioned resid norm 4.252589693890e+01 true resid norm 1.471904261226e-06 ||r(i)||/||b|| 1.471905404648e-06 >>>>> 7 KSP preconditioned resid norm 5.128476471782e+00 true resid norm 1.643725157865e-07 ||r(i)||/||b|| 1.643726434763e-07 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 4.311901915856e-01 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 4.345765068989e+07 at iteration 8 >>>>> 8 KSP preconditioned resid norm 4.311901915856e-01 true resid norm 1.166123921637e-08 ||r(i)||/||b|| 1.166124827519e-08 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.373662391739e-09 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.356628084813e-02 at iteration 2 >>>>> 2 KSP unpreconditioned resid norm 2.373662391739e-09 true resid norm 2.373662391658e-09 ||r(i)||/||b|| 3.226562990941e-08 >>>>> >>>>> [0] SNESSolve_NEWTONLS(): iter=2, linear solve iterations=2 >>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.343326231305e-02 near zero implies inconsistent rhs >>>>> [0] SNESSolve_NEWTONLS(): fnorm=7.3566280848133728e-02, gnorm=7.2259942496422647e-02, ynorm=6.3156901950486099e+04, lssucceed=0 >>>>> 3 2r: 7.23E-02 2x: 3.70E+09 2u: 6.32E+04 ir: 4.52E-02 iu: 5.00E+04 rsn: 0 >>>>> [0] SNESComputeJacobian(): Rebuilding preconditioner >>>>> >>>>> Residual norms for flow_ solve. >>>>> 0 KSP unpreconditioned resid norm 7.225994249642e-02 true resid norm 7.225994249642e-02 ||r(i)||/||b|| 1.000000000000e+00 >>>>> Residual norms for flow_sub_0_galerkin_ solve. >>>>> 0 KSP preconditioned resid norm 7.705582590638e+05 true resid norm 9.649751442741e-01 ||r(i)||/||b|| 1.000000000000e+00 >>>>> 1 KSP preconditioned resid norm 2.444424220392e+04 true resid norm 8.243110200738e-03 ||r(i)||/||b|| 8.542303135630e-03 >>>>> 2 KSP preconditioned resid norm 2.080899648412e+03 true resid norm 7.642343147053e-04 ||r(i)||/||b|| 7.919730567570e-04 >>>>> 3 KSP preconditioned resid norm 9.911171129874e+02 true resid norm 5.904182179180e-05 ||r(i)||/||b|| 6.118481096859e-05 >>>>> 4 KSP preconditioned resid norm 5.258230282482e+02 true resid norm 2.043366677644e-04 ||r(i)||/||b|| 2.117532964210e-04 >>>>> 5 KSP preconditioned resid norm 5.522830460456e+01 true resid norm 1.710780366056e-05 ||r(i)||/||b|| 1.772875059225e-05 >>>>> 6 KSP preconditioned resid norm 5.922280741715e+00 true resid norm 1.543198740828e-06 ||r(i)||/||b|| 1.599210870855e-06 >>>>> 7 KSP preconditioned resid norm 3.339500859115e-01 true resid norm 1.221335666427e-07 ||r(i)||/||b|| 1.265665414984e-07 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 3.329208597672e-02 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.705582590638e+05 at iteration 8 >>>>> 8 KSP preconditioned resid norm 3.329208597672e-02 true resid norm 9.758240835324e-09 ||r(i)||/||b|| 1.011242713683e-08 >>>>> [0] KSPConvergedDefault(): Linear solver has converged. Residual norm 2.697128456432e-11 is less than relative tolerance 1.000000000000e-07 times initial right hand side norm 7.225994249642e-02 at iteration 1 >>>>> 1 KSP unpreconditioned resid norm 2.697128456432e-11 true resid norm 2.697128457142e-11 ||r(i)||/||b|| 3.732536124389e-10 >>>>> >>>>> [0] SNESSolve_NEWTONLS(): iter=3, linear solve iterations=1 >>>>> [0] SNESNEWTONLSCheckResidual_Private(): ||J^T(F-Ax)||/||F-AX|| 4.329227684222e-02 near zero implies inconsistent rhs >>>>> [0] SNESSolve_NEWTONLS(): fnorm=7.2259942496422647e-02, gnorm=5.4435602192925014e-01, ynorm=2.7049750229137400e+04, lssucceed=0 >>>>> [0] SNESConvergedDefault(): Converged due to small update length: 2.704975022914e+04 < 1.000000000000e-05 * 3.702469482296e+09 >>>>> 4 2r: 5.44E-01 2x: 3.70E+09 2u: 2.70E+04 ir: 3.84E-01 iu: 2.34E+04 rsn: stol >>>>> Nonlinear flow_ solve converged due to CONVERGED_SNORM_RELATIVE iterations 4 >>>>> >>>>> >>>>> As the simulation advances this behaviour leads to frequent time step cuts because of 8 subsequently failed Newton iterations, which brings the simulation practically to a halt. >>>>> >>>>> Is the Block Jacobi not a good choice? Better ASM with huge overlap? Or is there something wrong with my RHS? Maybe the SNES, SNESLS, KSP tolerances need better tuning? >>>>> >>>>> Grateful for any clarifying words! >>>>> Robert >>>>> >>>>> >>>>> My SNES_view is: >>>>> >>>>> >>>>> SNES Object: (flow_) 2 MPI processes >>>>> type: newtonls >>>>> maximum iterations=8, maximum function evaluations=10000 >>>>> tolerances: relative=1e-05, absolute=1e-05, solution=1e-05 >>>>> total number of linear solver iterations=1 >>>>> total number of function evaluations=2 >>>>> norm schedule ALWAYS >>>>> SNESLineSearch Object: (flow_) 2 MPI processes >>>>> type: basic >>>>> maxstep=1.000000e+08, minlambda=1.000000e-05 >>>>> tolerances: relative=1.000000e-05, absolute=1.000000e-05, lambda=1.000000e-08 >>>>> maximum iterations=40 >>>>> using user-defined precheck step >>>>> KSP Object: (flow_) 2 MPI processes >>>>> type: fgmres >>>>> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >>>>> GMRES: happy breakdown tolerance 1e-30 >>>>> maximum iterations=200, initial guess is zero >>>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>>> right preconditioning >>>>> using UNPRECONDITIONED norm type for convergence test >>>>> PC Object: (flow_) 2 MPI processes >>>>> type: composite >>>>> Composite PC type - MULTIPLICATIVE >>>>> PCs on composite preconditioner follow >>>>> --------------------------------- >>>>> PC Object: (flow_sub_0_) 2 MPI processes >>>>> type: galerkin >>>>> Galerkin PC >>>>> KSP on Galerkin follow >>>>> --------------------------------- >>>>> KSP Object: (flow_sub_0_galerkin_) 2 MPI processes >>>>> type: gmres >>>>> GMRES: restart=30, using Classical (unmodified) Gram-Schmidt Orthogonalization with no iterative refinement >>>>> GMRES: happy breakdown tolerance 1e-30 >>>>> maximum iterations=200, initial guess is zero >>>>> tolerances: relative=1e-07, absolute=1e-50, divergence=10000. >>>>> left preconditioning >>>>> using PRECONDITIONED norm type for convergence test >>>>> PC Object: (flow_sub_0_galerkin_) 2 MPI processes >>>>> type: hypre >>>>> HYPRE BoomerAMG preconditioning >>>>> HYPRE BoomerAMG: Cycle type V >>>>> HYPRE BoomerAMG: Maximum number of levels 25 >>>>> HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 >>>>> HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. >>>>> HYPRE BoomerAMG: Threshold for strong coupling 0.25 >>>>> HYPRE BoomerAMG: Interpolation truncation factor 0. >>>>> HYPRE BoomerAMG: Interpolation: max elements per row 0 >>>>> HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 >>>>> HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 >>>>> HYPRE BoomerAMG: Maximum row sums 0.9 >>>>> HYPRE BoomerAMG: Sweeps down 1 >>>>> HYPRE BoomerAMG: Sweeps up 1 >>>>> HYPRE BoomerAMG: Sweeps on coarse 1 >>>>> HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi >>>>> HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi >>>>> HYPRE BoomerAMG: Relax on coarse Gaussian-elimination >>>>> HYPRE BoomerAMG: Relax weight (all) 1. >>>>> HYPRE BoomerAMG: Outer relax weight (all) 1. >>>>> HYPRE BoomerAMG: Using CF-relaxation >>>>> HYPRE BoomerAMG: Not using more complex smoothers. >>>>> HYPRE BoomerAMG: Measure type local >>>>> HYPRE BoomerAMG: Coarsen type Falgout >>>>> HYPRE BoomerAMG: Interpolation type classical >>>>> linear system matrix = precond matrix: >>>>> Mat Object: 2 MPI processes >>>>> type: mpiaij >>>>> rows=8000, cols=8000 >>>>> total: nonzeros=53600, allocated nonzeros=53600 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> not using I-node (on process 0) routines >>>>> linear system matrix = precond matrix: >>>>> Mat Object: (flow_) 2 MPI processes >>>>> type: mpibaij >>>>> rows=24000, cols=24000, bs=3 >>>>> total: nonzeros=482400, allocated nonzeros=482400 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> PC Object: (flow_sub_1_) 2 MPI processes >>>>> type: bjacobi >>>>> block Jacobi: number of blocks = 2 >>>>> Local solve is same for all blocks, in the following KSP and PC objects: >>>>> KSP Object: (flow_sub_1_sub_) 1 MPI processes >>>>> type: preonly >>>>> maximum iterations=10000, initial guess is zero >>>>> tolerances: relative=1e-05, absolute=1e-50, divergence=10000. <------ not working: -flow_sub_1_sub_ksp_rtol 1e-7 >>>>> left preconditioning >>>>> using NONE norm type for convergence test >>>>> PC Object: (flow_sub_1_sub_) 1 MPI processes >>>>> type: lu >>>>> out-of-place factorization >>>>> tolerance for zero pivot 2.22045e-14 >>>>> matrix ordering: nd >>>>> factor fill ratio given 5., needed 18.3108 >>>>> Factored matrix follows: >>>>> Mat Object: 1 MPI processes >>>>> type: seqbaij >>>>> rows=12000, cols=12000, bs=3 >>>>> package used to perform factorization: petsc >>>>> total: nonzeros=4350654, allocated nonzeros=4350654 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> block size is 3 >>>>> linear system matrix = precond matrix: >>>>> Mat Object: (flow_) 1 MPI processes >>>>> type: seqbaij >>>>> rows=12000, cols=12000, bs=3 >>>>> total: nonzeros=237600, allocated nonzeros=237600 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> block size is 3 >>>>> linear system matrix = precond matrix: >>>>> Mat Object: (flow_) 2 MPI processes >>>>> type: mpibaij >>>>> rows=24000, cols=24000, bs=3 >>>>> total: nonzeros=482400, allocated nonzeros=482400 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> --------------------------------- >>>>> linear system matrix = precond matrix: >>>>> Mat Object: (flow_) 2 MPI processes >>>>> type: mpibaij >>>>> rows=24000, cols=24000, bs=3 >>>>> total: nonzeros=482400, allocated nonzeros=482400 >>>>> total number of mallocs used during MatSetValues calls =0 >>>>> >>> > > -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: het_np_1_GMRES_LU.log Type: text/x-log Size: 37701 bytes Desc: not available URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: het_np_2_GMRES_LU.log Type: text/x-log Size: 38230 bytes Desc: not available URL: From dalcinl at gmail.com Fri Jul 7 15:12:01 2017 From: dalcinl at gmail.com (Lisandro Dalcin) Date: Fri, 7 Jul 2017 23:12:01 +0300 Subject: [petsc-users] TS for explicit equations In-Reply-To: References: Message-ID: On 6 July 2017 at 17:10, Alejandro D Otero wrote: > > # Set rhs function > ts.setRHSFunction(self.evalRHSFunction, self.g) > (where evalRHSFunction has the form f(self, ts, t, Vort, f)) > Please double check that the RHS function "outputs" the result in the passed-in vector "f", my guess is that you are just returning a new vector that is eventually ignored. -- Lisandro Dalcin ============ Research Scientist Computer, Electrical and Mathematical Sciences & Engineering (CEMSE) Extreme Computing Research Center (ECRC) King Abdullah University of Science and Technology (KAUST) http://ecrc.kaust.edu.sa/ 4700 King Abdullah University of Science and Technology al-Khawarizmi Bldg (Bldg 1), Office # 0109 Thuwal 23955-6900, Kingdom of Saudi Arabia http://www.kaust.edu.sa Office Phone: +966 12 808-0459 From mfadams at lbl.gov Sun Jul 9 07:05:51 2017 From: mfadams at lbl.gov (Mark Adams) Date: Sun, 9 Jul 2017 08:05:51 -0400 Subject: [petsc-users] Issue using multi-grid as a pre-conditioner with KSP for a Poisson problem In-Reply-To: References: <89C033B5-529D-4B36-B4AF-2EC35CA2CCAB@aclectic.com> <4D5B3921-810B-49AD-97E9-8BF1DECBF655@aclectic.com> Message-ID: > > > > What are the differences between gamg and mg with -pc_mg_galerkin option > (apart from the default smoother/coarse grid solver options, which I > identified by comparing the ksp_view output)? Perhaps there?s an issue with > the restriction, as you suggest? > Not sure if this got answered. GAMG is for unstructured problems. A "pure" AMG method. mg with -pc_mg_galerkin is semi-AMG, it still has geometric interpolation, and it is generally better if you can use it. -------------- next part -------------- An HTML attachment was scrubbed... URL: From mailinglists at xgm.de Mon Jul 10 03:22:50 2017 From: mailinglists at xgm.de (Florian Lindner) Date: Mon, 10 Jul 2017 16:22:50 +0800 Subject: [petsc-users] Understanding preallocation for MPI In-Reply-To: References: Message-ID: <3d7ca106-c1da-e9df-a7de-0b75aad2bad3@xgm.de> Hey, one more question about preallocation: I can determine if a column index is diagonal or off-diagonal using that code if (col >= col_range_start and col < col_range_end) d_nnz[relative_row]++; else o_nnz[relative_row]++; My code, however uses index sets from which a ISlocalToGlobalMapping created: // Creates a mapping from permutation and use that for the cols ierr = ISCreateGeneral(PETSC_COMM_WORLD, local_cols, permutation.data(), PETSC_COPY_VALUES, &ISlocal); CHKERRV(ierr); ierr = ISSetPermutation(ISlocal); CHKERRV(ierr); ierr = ISAllGather(ISlocal, &ISglobal); CHKERRV(ierr); // Gather the IS from all processors ierr = ISLocalToGlobalMappingCreateIS(ISglobal, &ISmapping); CHKERRV(ierr); // Make it a mapping // Create an identity mapping and use that for the rows of A. ierr = ISCreateStride(PETSC_COMM_WORLD, local_rows, row_range_start, 1, &ISidentity); CHKERRV(ierr); ierr = ISSetIdentity(ISidentity); CHKERRV(ierr); ierr = ISAllGather(ISidentity, &ISidentityGlobal); CHKERRV(ierr); ierr = ISLocalToGlobalMappingCreateIS(ISidentityGlobal, &ISidentityMapping); CHKERRV(ierr); ierr = MatSetLocalToGlobalMapping(A, ISidentityMapping, ISmapping); CHKERRV(ierr); since SetPreallocation routines define the diagonal / off-diagonal blocks from the petsc ordering, I have to translate the col to a petsc_col. What is the best / fastest way to do that? Is that the way to go? PetscInt mapSize; ISLocalToGlobalMappingGetSize(ISmapping, &mapSize); const PetscInt *mapIndizes; ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); Thanks, Florian Am 07.07.2017 um 17:31 schrieb Florian Lindner: > Hello, > > I'm having some struggle understanding the preallocation for MPIAIJ matrices, especially when a value is in off-diagonal > vs. diagonal block. > > The small example program is at https://pastebin.com/67dXnGm3 > > In general it should be parallel, but right now I just run it in serial. > > According to my understanding of > > http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/Mat/MatMPIAIJSetPreallocation.html > > a entry is in the diagonal submatrix, if its row is in the OwnershipRange and its column is in OwnershipRangeColumn. > That also means that in a serial run, there is only a diagonal submatrix. > > However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when > > Inserting 6 elements in row 2, though I have exactly > > 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal submatrix of row 2) > > Error is: > > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: New nonzero at (2,5) caused a malloc > Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn off this check > > > What is wrong with my understanding? > > Thanks, > Florian > From stefano.zampini at gmail.com Mon Jul 10 03:36:24 2017 From: stefano.zampini at gmail.com (Stefano Zampini) Date: Mon, 10 Jul 2017 10:36:24 +0200 Subject: [petsc-users] Understanding preallocation for MPI In-Reply-To: <3d7ca106-c1da-e9df-a7de-0b75aad2bad3@xgm.de> References: <3d7ca106-c1da-e9df-a7de-0b75aad2bad3@xgm.de> Message-ID: Florian, Perhaps you might want to take a look at how this is done for MatIS https://bitbucket.org/petsc/petsc/src/f9d5775f43f69cbce5a7014a6ce3b24cc0e1214a/src/mat/impls/is/matis.c?at=master&fileviewer=file-view-default#matis.c-1050 Stefano Il 10 Lug 2017 10:23 AM, "Florian Lindner" ha scritto: > Hey, > > one more question about preallocation: > > I can determine if a column index is diagonal or off-diagonal using that > code > > if (col >= col_range_start and col < col_range_end) > d_nnz[relative_row]++; > else > o_nnz[relative_row]++; > > > My code, however uses index sets from which a ISlocalToGlobalMapping > created: > > // Creates a mapping from permutation and use that for the cols > ierr = ISCreateGeneral(PETSC_COMM_WORLD, local_cols, > permutation.data(), PETSC_COPY_VALUES, &ISlocal); CHKERRV(ierr); > ierr = ISSetPermutation(ISlocal); CHKERRV(ierr); > ierr = ISAllGather(ISlocal, &ISglobal); CHKERRV(ierr); // Gather the IS > from all processors > ierr = ISLocalToGlobalMappingCreateIS(ISglobal, &ISmapping); > CHKERRV(ierr); // Make it a mapping > > // Create an identity mapping and use that for the rows of A. > ierr = ISCreateStride(PETSC_COMM_WORLD, local_rows, row_range_start, 1, > &ISidentity); CHKERRV(ierr); > ierr = ISSetIdentity(ISidentity); CHKERRV(ierr); > ierr = ISAllGather(ISidentity, &ISidentityGlobal); CHKERRV(ierr); > ierr = ISLocalToGlobalMappingCreateIS(ISidentityGlobal, > &ISidentityMapping); CHKERRV(ierr); > > ierr = MatSetLocalToGlobalMapping(A, ISidentityMapping, ISmapping); > CHKERRV(ierr); > > since SetPreallocation routines define the diagonal / off-diagonal blocks > from the petsc ordering, I have to translate > the col to a petsc_col. > > What is the best / fastest way to do that? > > Is that the way to go? > > PetscInt mapSize; > ISLocalToGlobalMappingGetSize(ISmapping, &mapSize); > const PetscInt *mapIndizes; > ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); > > Thanks, > Florian > > > > Am 07.07.2017 um 17:31 schrieb Florian Lindner: > > Hello, > > > > I'm having some struggle understanding the preallocation for MPIAIJ > matrices, especially when a value is in off-diagonal > > vs. diagonal block. > > > > The small example program is at https://pastebin.com/67dXnGm3 > > > > In general it should be parallel, but right now I just run it in serial. > > > > According to my understanding of > > > > http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/ > Mat/MatMPIAIJSetPreallocation.html > > > > a entry is in the diagonal submatrix, if its row is in the > OwnershipRange and its column is in OwnershipRangeColumn. > > That also means that in a serial run, there is only a diagonal submatrix. > > > > However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when > > > > Inserting 6 elements in row 2, though I have exactly > > > > 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal > submatrix of row 2) > > > > Error is: > > > > [0]PETSC ERROR: Argument out of range > > [0]PETSC ERROR: New nonzero at (2,5) caused a malloc > > Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to > turn off this check > > > > > > What is wrong with my understanding? > > > > Thanks, > > Florian > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From mailinglists at xgm.de Mon Jul 10 04:18:24 2017 From: mailinglists at xgm.de (Florian Lindner) Date: Mon, 10 Jul 2017 17:18:24 +0800 Subject: [petsc-users] Understanding preallocation for MPI In-Reply-To: References: <3d7ca106-c1da-e9df-a7de-0b75aad2bad3@xgm.de> Message-ID: <7be10787-75bc-6047-654a-a800563c8046@xgm.de> Hey Stefano, Am 10.07.2017 um 16:36 schrieb Stefano Zampini: > Florian, > > Perhaps you might want to take a look at how this is done for MatIS > > https://bitbucket.org/petsc/petsc/src/f9d5775f43f69cbce5a7014a6ce3b24cc0e1214a/src/mat/impls/is/matis.c?at=master&fileviewer=file-view-default#matis.c-1050 to what piece of code your are specifically refering to? Line 655, MatSetValuesLocal_SubMat_IS? and I should use ISLocalToGlobalMappingApply? but this, if I understand correctly, would involve such a call for every index. Right now, my preallocation loop looks like: PetscInt d_nnz[local_rows], o_nnz[local_rows]; PetscInt mapSize; ISLocalToGlobalMappingGetSize(ISmapping, &mapSize); const PetscInt *mapIndizes; ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); // is called just once for (int row = row_range_start; row < row_range_end; row++) { PetscInt relative_row = row - row_range_start; d_nnz[relative_row] = 0; o_nnz[relative_row] = 0; int colStart = row - nz_ratio/2 * size; int colEnd = row + nz_ratio/2 * size; colStart = (colStart < 0) ? 0 : colStart; colEnd = (colEnd > size) ? size : colEnd; for (int col = 0; col < global_cols; col++) { if (col >= colStart and col < colEnd) { int petsc_col = mapIndizes[col]; // should be cheap if (petsc_col >= col_range_start and petsc_col < col_range_end) { d_nnz[relative_row]++; } else { o_nnz[relative_row]++; } } } } ierr = MatMPIAIJSetPreallocation(A, 0, d_nnz, 0, o_nnz); CHKERRQ(ierr); Best, Florian > > Stefano > > Il 10 Lug 2017 10:23 AM, "Florian Lindner" > ha scritto: > > Hey, > > one more question about preallocation: > > I can determine if a column index is diagonal or off-diagonal using that code > > if (col >= col_range_start and col < col_range_end) > d_nnz[relative_row]++; > else > o_nnz[relative_row]++; > > > My code, however uses index sets from which a ISlocalToGlobalMapping created: > > // Creates a mapping from permutation and use that for the cols > ierr = ISCreateGeneral(PETSC_COMM_WORLD, local_cols, permutation.data(), PETSC_COPY_VALUES, &ISlocal); CHKERRV(ierr); > ierr = ISSetPermutation(ISlocal); CHKERRV(ierr); > ierr = ISAllGather(ISlocal, &ISglobal); CHKERRV(ierr); // Gather the IS from all processors > ierr = ISLocalToGlobalMappingCreateIS(ISglobal, &ISmapping); CHKERRV(ierr); // Make it a mapping > > // Create an identity mapping and use that for the rows of A. > ierr = ISCreateStride(PETSC_COMM_WORLD, local_rows, row_range_start, 1, &ISidentity); CHKERRV(ierr); > ierr = ISSetIdentity(ISidentity); CHKERRV(ierr); > ierr = ISAllGather(ISidentity, &ISidentityGlobal); CHKERRV(ierr); > ierr = ISLocalToGlobalMappingCreateIS(ISidentityGlobal, &ISidentityMapping); CHKERRV(ierr); > > ierr = MatSetLocalToGlobalMapping(A, ISidentityMapping, ISmapping); CHKERRV(ierr); > > since SetPreallocation routines define the diagonal / off-diagonal blocks from the petsc ordering, I have to translate > the col to a petsc_col. > > What is the best / fastest way to do that? > > Is that the way to go? > > PetscInt mapSize; > ISLocalToGlobalMappingGetSize(ISmapping, &mapSize); > const PetscInt *mapIndizes; > ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); > > Thanks, > Florian > > > > Am 07.07.2017 um 17:31 schrieb Florian Lindner: > > Hello, > > > > I'm having some struggle understanding the preallocation for MPIAIJ matrices, especially when a value is in > off-diagonal > > vs. diagonal block. > > > > The small example program is at https://pastebin.com/67dXnGm3 > > > > In general it should be parallel, but right now I just run it in serial. > > > > According to my understanding of > > > > http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/Mat/MatMPIAIJSetPreallocation.html > > > > > a entry is in the diagonal submatrix, if its row is in the OwnershipRange and its column is in OwnershipRangeColumn. > > That also means that in a serial run, there is only a diagonal submatrix. > > > > However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when > > > > Inserting 6 elements in row 2, though I have exactly > > > > 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal submatrix of row 2) > > > > Error is: > > > > [0]PETSC ERROR: Argument out of range > > [0]PETSC ERROR: New nonzero at (2,5) caused a malloc > > Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn off this check > > > > > > What is wrong with my understanding? > > > > Thanks, > > Florian > > > From stefano.zampini at gmail.com Mon Jul 10 04:20:39 2017 From: stefano.zampini at gmail.com (Stefano Zampini) Date: Mon, 10 Jul 2017 11:20:39 +0200 Subject: [petsc-users] Understanding preallocation for MPI In-Reply-To: References: <3d7ca106-c1da-e9df-a7de-0b75aad2bad3@xgm.de> <7be10787-75bc-6047-654a-a800563c8046@xgm.de> Message-ID: Look at the function that begins at line 1050 as the link should redirect to Il 10 Lug 2017 11:18 AM, "Florian Lindner" ha scritto: Hey Stefano, Am 10.07.2017 um 16:36 schrieb Stefano Zampini: > Florian, > > Perhaps you might want to take a look at how this is done for MatIS > > https://bitbucket.org/petsc/petsc/src/f9d5775f43f69cbce5a7014a6ce3b2 4cc0e1214a/src/mat/impls/is/matis.c?at=master&fileviewer= file-view-default#matis.c-1050 to what piece of code your are specifically refering to? Line 655, MatSetValuesLocal_SubMat_IS? and I should use ISLocalToGlobalMappingApply? but this, if I understand correctly, would involve such a call for every index. Right now, my preallocation loop looks like: PetscInt d_nnz[local_rows], o_nnz[local_rows]; PetscInt mapSize; ISLocalToGlobalMappingGetSize(ISmapping, &mapSize); const PetscInt *mapIndizes; ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); // is called just once for (int row = row_range_start; row < row_range_end; row++) { PetscInt relative_row = row - row_range_start; d_nnz[relative_row] = 0; o_nnz[relative_row] = 0; int colStart = row - nz_ratio/2 * size; int colEnd = row + nz_ratio/2 * size; colStart = (colStart < 0) ? 0 : colStart; colEnd = (colEnd > size) ? size : colEnd; for (int col = 0; col < global_cols; col++) { if (col >= colStart and col < colEnd) { int petsc_col = mapIndizes[col]; // should be cheap if (petsc_col >= col_range_start and petsc_col < col_range_end) { d_nnz[relative_row]++; } else { o_nnz[relative_row]++; } } } } ierr = MatMPIAIJSetPreallocation(A, 0, d_nnz, 0, o_nnz); CHKERRQ(ierr); Best, Florian > > Stefano > > Il 10 Lug 2017 10:23 AM, "Florian Lindner" > ha scritto: > > Hey, > > one more question about preallocation: > > I can determine if a column index is diagonal or off-diagonal using that code > > if (col >= col_range_start and col < col_range_end) > d_nnz[relative_row]++; > else > o_nnz[relative_row]++; > > > My code, however uses index sets from which a ISlocalToGlobalMapping created: > > // Creates a mapping from permutation and use that for the cols > ierr = ISCreateGeneral(PETSC_COMM_WORLD, local_cols, permutation.data(), PETSC_COPY_VALUES, &ISlocal); CHKERRV(ierr); > ierr = ISSetPermutation(ISlocal); CHKERRV(ierr); > ierr = ISAllGather(ISlocal, &ISglobal); CHKERRV(ierr); // Gather the IS from all processors > ierr = ISLocalToGlobalMappingCreateIS(ISglobal, &ISmapping); CHKERRV(ierr); // Make it a mapping > > // Create an identity mapping and use that for the rows of A. > ierr = ISCreateStride(PETSC_COMM_WORLD, local_rows, row_range_start, 1, &ISidentity); CHKERRV(ierr); > ierr = ISSetIdentity(ISidentity); CHKERRV(ierr); > ierr = ISAllGather(ISidentity, &ISidentityGlobal); CHKERRV(ierr); > ierr = ISLocalToGlobalMappingCreateIS(ISidentityGlobal, &ISidentityMapping); CHKERRV(ierr); > > ierr = MatSetLocalToGlobalMapping(A, ISidentityMapping, ISmapping); CHKERRV(ierr); > > since SetPreallocation routines define the diagonal / off-diagonal blocks from the petsc ordering, I have to translate > the col to a petsc_col. > > What is the best / fastest way to do that? > > Is that the way to go? > > PetscInt mapSize; > ISLocalToGlobalMappingGetSize(ISmapping, &mapSize); > const PetscInt *mapIndizes; > ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); > > Thanks, > Florian > > > > Am 07.07.2017 um 17:31 schrieb Florian Lindner: > > Hello, > > > > I'm having some struggle understanding the preallocation for MPIAIJ matrices, especially when a value is in > off-diagonal > > vs. diagonal block. > > > > The small example program is at https://pastebin.com/67dXnGm3 > > > > In general it should be parallel, but right now I just run it in serial. > > > > According to my understanding of > > > > http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/ Mat/MatMPIAIJSetPreallocation.html > > > > > a entry is in the diagonal submatrix, if its row is in the OwnershipRange and its column is in OwnershipRangeColumn. > > That also means that in a serial run, there is only a diagonal submatrix. > > > > However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when > > > > Inserting 6 elements in row 2, though I have exactly > > > > 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal submatrix of row 2) > > > > Error is: > > > > [0]PETSC ERROR: Argument out of range > > [0]PETSC ERROR: New nonzero at (2,5) caused a malloc > > Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn off this check > > > > > > What is wrong with my understanding? > > > > Thanks, > > Florian > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Mon Jul 10 13:45:42 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Mon, 10 Jul 2017 13:45:42 -0500 Subject: [petsc-users] Understanding preallocation for MPI In-Reply-To: <3d7ca106-c1da-e9df-a7de-0b75aad2bad3@xgm.de> References: <3d7ca106-c1da-e9df-a7de-0b75aad2bad3@xgm.de> Message-ID: You might consider using http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatPreallocateInitialize.html and http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatPreallocateSetLocal.html#MatPreallocateSetLocal and friends These take out some of the busywork of setting the preallocation arrays. They are macros in petscmat.h so even if you don't use them you can see the code they use. Barry > On Jul 10, 2017, at 3:22 AM, Florian Lindner wrote: > > Hey, > > one more question about preallocation: > > I can determine if a column index is diagonal or off-diagonal using that code > > if (col >= col_range_start and col < col_range_end) > d_nnz[relative_row]++; > else > o_nnz[relative_row]++; > > > My code, however uses index sets from which a ISlocalToGlobalMapping created: > > // Creates a mapping from permutation and use that for the cols > ierr = ISCreateGeneral(PETSC_COMM_WORLD, local_cols, permutation.data(), PETSC_COPY_VALUES, &ISlocal); CHKERRV(ierr); > ierr = ISSetPermutation(ISlocal); CHKERRV(ierr); > ierr = ISAllGather(ISlocal, &ISglobal); CHKERRV(ierr); // Gather the IS from all processors > ierr = ISLocalToGlobalMappingCreateIS(ISglobal, &ISmapping); CHKERRV(ierr); // Make it a mapping > > // Create an identity mapping and use that for the rows of A. > ierr = ISCreateStride(PETSC_COMM_WORLD, local_rows, row_range_start, 1, &ISidentity); CHKERRV(ierr); > ierr = ISSetIdentity(ISidentity); CHKERRV(ierr); > ierr = ISAllGather(ISidentity, &ISidentityGlobal); CHKERRV(ierr); > ierr = ISLocalToGlobalMappingCreateIS(ISidentityGlobal, &ISidentityMapping); CHKERRV(ierr); > > ierr = MatSetLocalToGlobalMapping(A, ISidentityMapping, ISmapping); CHKERRV(ierr); > > since SetPreallocation routines define the diagonal / off-diagonal blocks from the petsc ordering, I have to translate > the col to a petsc_col. > > What is the best / fastest way to do that? > > Is that the way to go? > > PetscInt mapSize; > ISLocalToGlobalMappingGetSize(ISmapping, &mapSize); > const PetscInt *mapIndizes; > ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); > > Thanks, > Florian > > > > Am 07.07.2017 um 17:31 schrieb Florian Lindner: >> Hello, >> >> I'm having some struggle understanding the preallocation for MPIAIJ matrices, especially when a value is in off-diagonal >> vs. diagonal block. >> >> The small example program is at https://pastebin.com/67dXnGm3 >> >> In general it should be parallel, but right now I just run it in serial. >> >> According to my understanding of >> >> http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/Mat/MatMPIAIJSetPreallocation.html >> >> a entry is in the diagonal submatrix, if its row is in the OwnershipRange and its column is in OwnershipRangeColumn. >> That also means that in a serial run, there is only a diagonal submatrix. >> >> However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when >> >> Inserting 6 elements in row 2, though I have exactly >> >> 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal submatrix of row 2) >> >> Error is: >> >> [0]PETSC ERROR: Argument out of range >> [0]PETSC ERROR: New nonzero at (2,5) caused a malloc >> Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn off this check >> >> >> What is wrong with my understanding? >> >> Thanks, >> Florian >> From jason.lefley at aclectic.com Mon Jul 10 16:37:25 2017 From: jason.lefley at aclectic.com (Jason Lefley) Date: Mon, 10 Jul 2017 16:37:25 -0500 Subject: [petsc-users] Issue using multi-grid as a pre-conditioner with KSP for a Poisson problem In-Reply-To: References: <89C033B5-529D-4B36-B4AF-2EC35CA2CCAB@aclectic.com> <4D5B3921-810B-49AD-97E9-8BF1DECBF655@aclectic.com> Message-ID: <7122C8CD-C43D-4000-995E-E2EFB9178546@aclectic.com> Thanks for the clarification. > On Jul 9, 2017, at 7:05 AM, Mark Adams wrote: > > > > What are the differences between gamg and mg with -pc_mg_galerkin option (apart from the default smoother/coarse grid solver options, which I identified by comparing the ksp_view output)? Perhaps there?s an issue with the restriction, as you suggest? > > > Not sure if this got answered. GAMG is for unstructured problems. A "pure" AMG method. > > mg with -pc_mg_galerkin is semi-AMG, it still has geometric interpolation, and it is generally better if you can use it. -------------- next part -------------- An HTML attachment was scrubbed... URL: From 960961097 at qq.com Tue Jul 11 16:10:50 2017 From: 960961097 at qq.com (=?utf-8?Q?=E9=92=9F=E7=94=9A?=) Date: Wed, 12 Jul 2017 05:10:50 +0800 Subject: [petsc-users] (no subject) Message-ID: <9dbae2d129cc696e@9732fb1c5f595f1e> An HTML attachment was scrubbed... URL: From spandey2 at wpi.edu Wed Jul 12 11:56:21 2017 From: spandey2 at wpi.edu (Pandey, Siddhant) Date: Wed, 12 Jul 2017 16:56:21 +0000 Subject: [petsc-users] SLEPC solvers not converging in latest version Message-ID: We recently updated our installation of PETSC and SLEPC from an older version, and eigenvalue problems converging in the previous installation is not converging anymore (diagonalization never comes to an end). On using -info, the following message keeps repeating during diagonalization: [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged [0] STMatSolve(): Linear solve iterations=1 [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged [0] STMatSolve(): Linear solve iterations=1 [0] BV_SafeSqrt(): Zero norm, either the vector is zero or a semi-inner product is being used [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged [0] STMatSolve(): Linear solve iterations=1 [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged [0] STMatSolve(): Linear solve iterations=1 As can be seen, iteration number remains 1. The issue gets resolved with a smaller sized matrix. Currently I am using a 10648 x 10648 matrix, and PETSC is configured for complex values. What changes do I have to make to make my codes work in the new installation? This seems to be a version specific issue. Thanks, Sidd WPI -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Wed Jul 12 12:45:20 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Wed, 12 Jul 2017 19:45:20 +0200 Subject: [petsc-users] SLEPC solvers not converging in latest version In-Reply-To: References: Message-ID: > El 12 jul 2017, a las 18:56, Pandey, Siddhant escribi?: > > We recently updated our installation of PETSC and SLEPC from an older version, and eigenvalue problems converging in the previous installation is not converging anymore (diagonalization never comes to an end). On using -info, the following message keeps repeating during diagonalization: > > [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged > [0] STMatSolve(): Linear solve iterations=1 > [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged > [0] STMatSolve(): Linear solve iterations=1 > [0] BV_SafeSqrt(): Zero norm, either the vector is zero or a semi-inner product is being used > [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged > [0] STMatSolve(): Linear solve iterations=1 > [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged > [0] STMatSolve(): Linear solve iterations=1 > > As can be seen, iteration number remains 1. The issue gets resolved with a smaller sized matrix. Currently I am using a 10648 x 10648 matrix, and PETSC is configured for complex values. > > What changes do I have to make to make my codes work in the new installation? This seems to be a version specific issue. > > > Thanks, > Sidd > WPI I don't understand why are you getting the BV message. Maybe your B-matrix is singular, but it is not sufficient to explain this. If possible, send me your matrices and I will try to reproduce the problem (I would also need to know all the settings, which can be displayed with -eps_view or -eps_view_pre). Jose From hzhang at mcs.anl.gov Wed Jul 12 12:53:15 2017 From: hzhang at mcs.anl.gov (Hong) Date: Wed, 12 Jul 2017 12:53:15 -0500 Subject: [petsc-users] SLEPC solvers not converging in latest version In-Reply-To: References: Message-ID: Add option '-ksp_error_if_not_converged'. I suspect the matrix has zero pivot. Hong On Wed, Jul 12, 2017 at 12:45 PM, Jose E. Roman wrote: > > > El 12 jul 2017, a las 18:56, Pandey, Siddhant > escribi?: > > > > We recently updated our installation of PETSC and SLEPC from an older > version, and eigenvalue problems converging in the previous installation is > not converging anymore (diagonalization never comes to an end). On using > -info, the following message keeps repeating during diagonalization: > > > > [0] PCSetUp(): Leaving PC with identical preconditioner since operator > is unchanged > > [0] STMatSolve(): Linear solve iterations=1 > > [0] PCSetUp(): Leaving PC with identical preconditioner since operator > is unchanged > > [0] STMatSolve(): Linear solve iterations=1 > > [0] BV_SafeSqrt(): Zero norm, either the vector is zero or a semi-inner > product is being used > > [0] PCSetUp(): Leaving PC with identical preconditioner since operator > is unchanged > > [0] STMatSolve(): Linear solve iterations=1 > > [0] PCSetUp(): Leaving PC with identical preconditioner since operator > is unchanged > > [0] STMatSolve(): Linear solve iterations=1 > > > > As can be seen, iteration number remains 1. The issue gets resolved with > a smaller sized matrix. Currently I am using a 10648 x 10648 matrix, and > PETSC is configured for complex values. > > > > What changes do I have to make to make my codes work in the new > installation? This seems to be a version specific issue. > > > > > > Thanks, > > Sidd > > WPI > > I don't understand why are you getting the BV message. Maybe your B-matrix > is singular, but it is not sufficient to explain this. If possible, send me > your matrices and I will try to reproduce the problem (I would also need to > know all the settings, which can be displayed with -eps_view or > -eps_view_pre). > > Jose > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Wed Jul 12 12:58:24 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Wed, 12 Jul 2017 19:58:24 +0200 Subject: [petsc-users] SLEPC solvers not converging in latest version In-Reply-To: References: Message-ID: Hong: in the latests versions of SLEPc we turn on this option by default (except in some solvers such as JD), so I don't think the problem is in the KSP solve. Jose > El 12 jul 2017, a las 19:53, Hong escribi?: > > Add option '-ksp_error_if_not_converged'. I suspect the matrix has zero pivot. > Hong > > On Wed, Jul 12, 2017 at 12:45 PM, Jose E. Roman wrote: > > > El 12 jul 2017, a las 18:56, Pandey, Siddhant escribi?: > > > > We recently updated our installation of PETSC and SLEPC from an older version, and eigenvalue problems converging in the previous installation is not converging anymore (diagonalization never comes to an end). On using -info, the following message keeps repeating during diagonalization: > > > > [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged > > [0] STMatSolve(): Linear solve iterations=1 > > [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged > > [0] STMatSolve(): Linear solve iterations=1 > > [0] BV_SafeSqrt(): Zero norm, either the vector is zero or a semi-inner product is being used > > [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged > > [0] STMatSolve(): Linear solve iterations=1 > > [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged > > [0] STMatSolve(): Linear solve iterations=1 > > > > As can be seen, iteration number remains 1. The issue gets resolved with a smaller sized matrix. Currently I am using a 10648 x 10648 matrix, and PETSC is configured for complex values. > > > > What changes do I have to make to make my codes work in the new installation? This seems to be a version specific issue. > > > > > > Thanks, > > Sidd > > WPI > > I don't understand why are you getting the BV message. Maybe your B-matrix is singular, but it is not sufficient to explain this. If possible, send me your matrices and I will try to reproduce the problem (I would also need to know all the settings, which can be displayed with -eps_view or -eps_view_pre). > > Jose > > From jroman at dsic.upv.es Wed Jul 12 13:02:55 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Wed, 12 Jul 2017 20:02:55 +0200 Subject: [petsc-users] SLEPC solvers not converging in latest version In-Reply-To: References: Message-ID: <11AC9CF4-DE0D-4A46-B8F0-618C005E70A5@dsic.upv.es> Let me correct my last message: we set this option in the development version (master), so yes, in 3.7 it may be good to try -ksp_error_if_not_converged Sorry for the noise. Jose > El 12 jul 2017, a las 19:58, Jose E. Roman escribi?: > > Hong: in the latests versions of SLEPc we turn on this option by default (except in some solvers such as JD), so I don't think the problem is in the KSP solve. > Jose > > >> El 12 jul 2017, a las 19:53, Hong escribi?: >> >> Add option '-ksp_error_if_not_converged'. I suspect the matrix has zero pivot. >> Hong >> >> On Wed, Jul 12, 2017 at 12:45 PM, Jose E. Roman wrote: >> >>> El 12 jul 2017, a las 18:56, Pandey, Siddhant escribi?: >>> >>> We recently updated our installation of PETSC and SLEPC from an older version, and eigenvalue problems converging in the previous installation is not converging anymore (diagonalization never comes to an end). On using -info, the following message keeps repeating during diagonalization: >>> >>> [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged >>> [0] STMatSolve(): Linear solve iterations=1 >>> [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged >>> [0] STMatSolve(): Linear solve iterations=1 >>> [0] BV_SafeSqrt(): Zero norm, either the vector is zero or a semi-inner product is being used >>> [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged >>> [0] STMatSolve(): Linear solve iterations=1 >>> [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged >>> [0] STMatSolve(): Linear solve iterations=1 >>> >>> As can be seen, iteration number remains 1. The issue gets resolved with a smaller sized matrix. Currently I am using a 10648 x 10648 matrix, and PETSC is configured for complex values. >>> >>> What changes do I have to make to make my codes work in the new installation? This seems to be a version specific issue. >>> >>> >>> Thanks, >>> Sidd >>> WPI >> >> I don't understand why are you getting the BV message. Maybe your B-matrix is singular, but it is not sufficient to explain this. If possible, send me your matrices and I will try to reproduce the problem (I would also need to know all the settings, which can be displayed with -eps_view or -eps_view_pre). >> >> Jose >> >> > From gmulas at oa-cagliari.inaf.it Wed Jul 12 13:09:23 2017 From: gmulas at oa-cagliari.inaf.it (Giacomo Mulas) Date: Wed, 12 Jul 2017 20:09:23 +0200 (CEST) Subject: [petsc-users] Does the ciss solver ignore deflation space? Message-ID: Hello, I am trying to experiment with the ciss solver to see if it can be more efficient for my calculation. I need to compute the eigenpairs of a sparse real symmetric matrix. I don't know in advance how many I will need to compute, the convergence condition is on the subspace of converged eigenvectors. I don't know in advance the range(s) in which "good" eigensolutions (for my problem) will be. So my approach with other solvers has been to compute some eigensolutions for each call to epssolve, each time setting a deflation space with previously found eigenvectors. Not superefficient but it works, and it scales. However, when I attempt this with the ciss solver I keep getting the same eigenpairs over and over, regardless of the deflation space. Any clue as to why this happens and/or how to cure this? Thanks in advance, best regards Giacomo -- _________________________________________________________________ Giacomo Mulas _________________________________________________________________ INAF - Osservatorio Astronomico di Cagliari via della scienza 5 - 09047 Selargius (CA) tel. +39 070 71180244 mob. : +39 329 6603810 _________________________________________________________________ "When the storms are raging around you, stay right where you are" (Freddy Mercury) _________________________________________________________________ From jroman at dsic.upv.es Wed Jul 12 13:41:21 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Wed, 12 Jul 2017 20:41:21 +0200 Subject: [petsc-users] Does the ciss solver ignore deflation space? In-Reply-To: References: Message-ID: > El 12 jul 2017, a las 20:09, Giacomo Mulas escribi?: > > Hello, I am trying to experiment with the ciss solver to see if it can be > more efficient for my calculation. I need to compute the eigenpairs of a > sparse real symmetric matrix. I don't know in advance how many I will need > to compute, the convergence condition is on the subspace of converged > eigenvectors. I don't know in advance the range(s) in which "good" > eigensolutions (for my problem) will be. > So my approach with other solvers has been to compute some > eigensolutions for each call to epssolve, each time setting a deflation > space with previously found eigenvectors. Not superefficient but it works, > and it scales. > However, when I attempt this with the ciss solver I keep getting the same > eigenpairs over and over, regardless of the deflation space. Any clue as to > why this happens and/or how to cure this? > > Thanks in advance, best regards > Giacomo The current implementation of CISS ignores the deflation space. I don't know if it makes sense to set constraints in the contour integral solver. The idea of CISS is that it computes all eigenvalues contained inside the region. So in your case, a possible strategy could be to use small, disjoint but adjacent regions, and repeat until all wanted eigenvalues are discovered. But CISS is generally quite costly. With default parameters, it will require many factorizations per each region. Jose From adenchfi at hawk.iit.edu Wed Jul 12 14:45:57 2017 From: adenchfi at hawk.iit.edu (Adam Denchfield) Date: Wed, 12 Jul 2017 14:45:57 -0500 Subject: [petsc-users] Rectangular matrices turned into square? Message-ID: Hi, I'm using the FEniCS package, which uses DOLFIN/petsc4py (and thus petsc). If I'm understanding the libraries right, I'm assembling rectangular matrices and sending them to be solved in a KrylovSolver. However, with -ksp_view, I'm seeing 2112x2112 matrices, not 1062x2112 matrices. Does PETSc do conversions like this automatically during preconditioning or something? Trying to identify if this would be a behaviour on PETSc's part. Regards, *Adam Denchfield* *Peer Career Coach - Career Services* Illinois Institute of Technology *Bachelors of Science in Applied Physics (2018)* Email: adenchfi at hawk.iit.edu My LinkedIn My ResearchGate Profile -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Jul 12 14:48:37 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 12 Jul 2017 14:48:37 -0500 Subject: [petsc-users] Rectangular matrices turned into square? In-Reply-To: References: Message-ID: <5EF4584F-BD6E-4F6D-9A5F-DD174FE3E204@mcs.anl.gov> Adam, Please send the output from KSP view. We don't "change" the matrix but we might have some intermediate matrix of that other side, or it could be a bug in our output. Barry > On Jul 12, 2017, at 2:45 PM, Adam Denchfield wrote: > > Hi, > > I'm using the FEniCS package, which uses DOLFIN/petsc4py (and thus petsc). If I'm understanding the libraries right, I'm assembling rectangular matrices and sending them to be solved in a KrylovSolver. However, with -ksp_view, I'm seeing 2112x2112 matrices, not 1062x2112 matrices. Does PETSc do conversions like this automatically during preconditioning or something? Trying to identify if this would be a behaviour on PETSc's part. > > Regards, > Adam Denchfield > Peer Career Coach - Career Services > Illinois Institute of Technology > Bachelors of Science in Applied Physics (2018) > Email: adenchfi at hawk.iit.edu > My LinkedIn My ResearchGate Profile From j.pogacnik at auckland.ac.nz Wed Jul 12 14:52:07 2017 From: j.pogacnik at auckland.ac.nz (Justin Pogacnik) Date: Wed, 12 Jul 2017 19:52:07 +0000 Subject: [petsc-users] NULL section fortran Message-ID: <1499889127627.57606@auckland.ac.nz> Hello, I'm assembling a global finite element stiffness matrix and using the DMPlexMatSetClosure command in fortran. Long ago, in the past, I've used to set the section input parameters to PETSC_NULL_OBJECT. That now returns an error -- no implicit type -- during compilation. Looking at the defined null objects for fortran I don't see a section option. What should I use to invoke the default sections? Hope this makes sense. Thanks! Justin -------------- next part -------------- An HTML attachment was scrubbed... URL: From adenchfi at hawk.iit.edu Wed Jul 12 14:55:13 2017 From: adenchfi at hawk.iit.edu (Adam Denchfield) Date: Wed, 12 Jul 2017 14:55:13 -0500 Subject: [petsc-users] Rectangular matrices turned into square? In-Reply-To: <5EF4584F-BD6E-4F6D-9A5F-DD174FE3E204@mcs.anl.gov> References: <5EF4584F-BD6E-4F6D-9A5F-DD174FE3E204@mcs.anl.gov> Message-ID: Hi, Below I've attached the text file with my ksp_view. It's a time-dependent problem so I included ten time-steps. The information doesn't seem to be much different in the multiple time steps. ______________ Regards, *Adam Denchfield* *Peer Career Coach - Career Services* Illinois Institute of Technology *Bachelors of Science in Applied Physics (2018)* Email: adenchfi at hawk.iit.edu My LinkedIn My ResearchGate Profile On Wed, Jul 12, 2017 at 2:48 PM, Barry Smith wrote: > > Adam, > > Please send the output from KSP view. We don't "change" the matrix but > we might have some intermediate matrix of that other side, or it could be a > bug in our output. > > Barry > > > On Jul 12, 2017, at 2:45 PM, Adam Denchfield > wrote: > > > > Hi, > > > > I'm using the FEniCS package, which uses DOLFIN/petsc4py (and thus > petsc). If I'm understanding the libraries right, I'm assembling > rectangular matrices and sending them to be solved in a KrylovSolver. > However, with -ksp_view, I'm seeing 2112x2112 matrices, not 1062x2112 > matrices. Does PETSc do conversions like this automatically during > preconditioning or something? Trying to identify if this would be a > behaviour on PETSc's part. > > > > Regards, > > Adam Denchfield > > Peer Career Coach - Career Services > > Illinois Institute of Technology > > Bachelors of Science in Applied Physics (2018) > > Email: adenchfi at hawk.iit.edu > > My LinkedIn My ResearchGate Profile > > -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=1056, cols=1056 package used to perform factorization: mumps total: nonzeros=51008, allocated nonzeros=51008 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 932479. [1] 869485. RINFO(2) (local estimated flops for the assembly after factorization): [0] 34069. [1] 32553. RINFO(3) (local estimated flops for the elimination after factorization): [0] 932479. [1] 869485. 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] 544 [1] 512 RINFOG(1) (global estimated flops for the elimination after analysis): 1.80196e+06 RINFOG(2) (global estimated flops for the assembly after factorization): 66622. RINFOG(3) (global estimated flops for the elimination after factorization): 1.80196e+06 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 51008 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 12612 INFOG(5) (estimated maximum front size in the complete tree): 73 INFOG(6) (number of nodes in the complete tree): 277 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): 51008 INFOG(10) (total integer space store the matrix factors after factorization): 12612 INFOG(11) (order of largest frontal matrix after factorization): 73 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): 51008 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)): 51008 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=1056, cols=1056 total: nonzeros=7264, allocated nonzeros=7264 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines KSP Object: 2 MPI processes type: bcgs maximum iterations=10000000 tolerances: relative=3e-15, absolute=3e-15, divergence=10000. left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=2112, cols=2112, bs=2 total: nonzeros=29056, allocated nonzeros=29056 total number of mallocs used during MatSetValues calls =0 using I-node (on process 0) routines: found 531 nodes, limit used is 5 KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=4160, cols=4160 package used to perform factorization: mumps total: nonzeros=308450, allocated nonzeros=308450 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 8.38453e+06 [1] 1.25452e+07 RINFO(2) (local estimated flops for the assembly after factorization): [0] 182266. [1] 301283. RINFO(3) (local estimated flops for the elimination after factorization): [0] 8.38453e+06 [1] 1.25452e+07 INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 6 [1] 7 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 6 [1] 7 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 1736 [1] 2424 RINFOG(1) (global estimated flops for the elimination after analysis): 2.09297e+07 RINFOG(2) (global estimated flops for the assembly after factorization): 483549. RINFOG(3) (global estimated flops for the elimination after factorization): 2.09297e+07 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 308450 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 49482 INFOG(5) (estimated maximum front size in the complete tree): 167 INFOG(6) (number of nodes in the complete tree): 881 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): 308450 INFOG(10) (total integer space store the matrix factors after factorization): 49482 INFOG(11) (order of largest frontal matrix after factorization): 167 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): 7 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 13 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 13 INFOG(20) (estimated number of entries in the factors): 308450 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 6 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 12 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)): 308450 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 4 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=4160, cols=4160 total: nonzeros=47360, allocated nonzeros=47360 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=1056, cols=1056 package used to perform factorization: mumps total: nonzeros=51008, allocated nonzeros=51008 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 932479. [1] 869485. RINFO(2) (local estimated flops for the assembly after factorization): [0] 34069. [1] 32553. RINFO(3) (local estimated flops for the elimination after factorization): [0] 932479. [1] 869485. 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] 544 [1] 512 RINFOG(1) (global estimated flops for the elimination after analysis): 1.80196e+06 RINFOG(2) (global estimated flops for the assembly after factorization): 66622. RINFOG(3) (global estimated flops for the elimination after factorization): 1.80196e+06 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 51008 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 12612 INFOG(5) (estimated maximum front size in the complete tree): 73 INFOG(6) (number of nodes in the complete tree): 277 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): 51008 INFOG(10) (total integer space store the matrix factors after factorization): 12612 INFOG(11) (order of largest frontal matrix after factorization): 73 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): 51008 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)): 51008 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=1056, cols=1056 total: nonzeros=7264, allocated nonzeros=7264 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines TC = 0.50000 TC = 0.50000 KSP Object: 2 MPI processes type: bcgs maximum iterations=10000000 tolerances: relative=3e-15, absolute=3e-15, divergence=10000. left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=2112, cols=2112, bs=2 total: nonzeros=29056, allocated nonzeros=29056 total number of mallocs used during MatSetValues calls =0 using I-node (on process 0) routines: found 531 nodes, limit used is 5 KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=4160, cols=4160 package used to perform factorization: mumps total: nonzeros=308450, allocated nonzeros=308450 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 8.38453e+06 [1] 1.25452e+07 RINFO(2) (local estimated flops for the assembly after factorization): [0] 182266. [1] 301283. RINFO(3) (local estimated flops for the elimination after factorization): [0] 8.38453e+06 [1] 1.25452e+07 INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 6 [1] 7 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 6 [1] 7 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 1736 [1] 2424 RINFOG(1) (global estimated flops for the elimination after analysis): 2.09297e+07 RINFOG(2) (global estimated flops for the assembly after factorization): 483549. RINFOG(3) (global estimated flops for the elimination after factorization): 2.09297e+07 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 308450 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 49482 INFOG(5) (estimated maximum front size in the complete tree): 167 INFOG(6) (number of nodes in the complete tree): 881 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): 308450 INFOG(10) (total integer space store the matrix factors after factorization): 49482 INFOG(11) (order of largest frontal matrix after factorization): 167 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): 7 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 13 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 13 INFOG(20) (estimated number of entries in the factors): 308450 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 6 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 12 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)): 308450 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 4 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=4160, cols=4160 total: nonzeros=47360, allocated nonzeros=47360 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=1056, cols=1056 package used to perform factorization: mumps total: nonzeros=51008, allocated nonzeros=51008 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 932479. [1] 869485. RINFO(2) (local estimated flops for the assembly after factorization): [0] 34069. [1] 32553. RINFO(3) (local estimated flops for the elimination after factorization): [0] 932479. [1] 869485. 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] 544 [1] 512 RINFOG(1) (global estimated flops for the elimination after analysis): 1.80196e+06 RINFOG(2) (global estimated flops for the assembly after factorization): 66622. RINFOG(3) (global estimated flops for the elimination after factorization): 1.80196e+06 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 51008 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 12612 INFOG(5) (estimated maximum front size in the complete tree): 73 INFOG(6) (number of nodes in the complete tree): 277 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): 51008 INFOG(10) (total integer space store the matrix factors after factorization): 12612 INFOG(11) (order of largest frontal matrix after factorization): 73 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): 51008 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)): 51008 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=1056, cols=1056 total: nonzeros=7264, allocated nonzeros=7264 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routine TC = 1.00000 TC = 1.00000 KSP Object: 2 MPI processes type: bcgs maximum iterations=10000000 tolerances: relative=3e-15, absolute=3e-15, divergence=10000. left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=2112, cols=2112, bs=2 total: nonzeros=29056, allocated nonzeros=29056 total number of mallocs used during MatSetValues calls =0 using I-node (on process 0) routines: found 531 nodes, limit used is 5 KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=4160, cols=4160 package used to perform factorization: mumps total: nonzeros=308450, allocated nonzeros=308450 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 8.38453e+06 [1] 1.25452e+07 RINFO(2) (local estimated flops for the assembly after factorization): [0] 182266. [1] 301283. RINFO(3) (local estimated flops for the elimination after factorization): [0] 8.38453e+06 [1] 1.25452e+07 INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 6 [1] 7 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 6 [1] 7 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 1736 [1] 2424 RINFOG(1) (global estimated flops for the elimination after analysis): 2.09297e+07 RINFOG(2) (global estimated flops for the assembly after factorization): 483549. RINFOG(3) (global estimated flops for the elimination after factorization): 2.09297e+07 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 308450 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 49482 INFOG(5) (estimated maximum front size in the complete tree): 167 INFOG(6) (number of nodes in the complete tree): 881 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): 308450 INFOG(10) (total integer space store the matrix factors after factorization): 49482 INFOG(11) (order of largest frontal matrix after factorization): 167 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): 7 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 13 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 13 INFOG(20) (estimated number of entries in the factors): 308450 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 6 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 12 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)): 308450 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 4 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=4160, cols=4160 total: nonzeros=47360, allocated nonzeros=47360 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=1056, cols=1056 package used to perform factorization: mumps total: nonzeros=51008, allocated nonzeros=51008 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 932479. [1] 869485. RINFO(2) (local estimated flops for the assembly after factorization): [0] 34069. [1] 32553. RINFO(3) (local estimated flops for the elimination after factorization): [0] 932479. [1] 869485. 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] 544 [1] 512 RINFOG(1) (global estimated flops for the elimination after analysis): 1.80196e+06 RINFOG(2) (global estimated flops for the assembly after factorization): 66622. RINFOG(3) (global estimated flops for the elimination after factorization): 1.80196e+06 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 51008 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 12612 INFOG(5) (estimated maximum front size in the complete tree): 73 INFOG(6) (number of nodes in the complete tree): 277 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): 51008 INFOG(10) (total integer space store the matrix factors after factorization): 12612 INFOG(11) (order of largest frontal matrix after factorization): 73 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): 51008 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)): 51008 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=1056, cols=1056 total: nonzeros=7264, allocated nonzeros=7264 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines TC = 1.50000 TC = 1.50000 KSP Object: 2 MPI processes type: bcgs maximum iterations=10000000 tolerances: relative=3e-15, absolute=3e-15, divergence=10000. left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=2112, cols=2112, bs=2 total: nonzeros=29056, allocated nonzeros=29056 total number of mallocs used during MatSetValues calls =0 using I-node (on process 0) routines: found 531 nodes, limit used is 5 KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=4160, cols=4160 package used to perform factorization: mumps total: nonzeros=308450, allocated nonzeros=308450 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 8.38453e+06 [1] 1.25452e+07 RINFO(2) (local estimated flops for the assembly after factorization): [0] 182266. [1] 301283. RINFO(3) (local estimated flops for the elimination after factorization): [0] 8.38453e+06 [1] 1.25452e+07 INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 6 [1] 7 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 6 [1] 7 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 1736 [1] 2424 RINFOG(1) (global estimated flops for the elimination after analysis): 2.09297e+07 RINFOG(2) (global estimated flops for the assembly after factorization): 483549. RINFOG(3) (global estimated flops for the elimination after factorization): 2.09297e+07 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 308450 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 49482 INFOG(5) (estimated maximum front size in the complete tree): 167 INFOG(6) (number of nodes in the complete tree): 881 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): 308450 INFOG(10) (total integer space store the matrix factors after factorization): 49482 INFOG(11) (order of largest frontal matrix after factorization): 167 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): 7 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 13 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 13 INFOG(20) (estimated number of entries in the factors): 308450 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 6 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 12 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)): 308450 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 4 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=4160, cols=4160 total: nonzeros=47360, allocated nonzeros=47360 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=1056, cols=1056 package used to perform factorization: mumps total: nonzeros=51008, allocated nonzeros=51008 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 932479. [1] 869485. RINFO(2) (local estimated flops for the assembly after factorization): [0] 34069. [1] 32553. RINFO(3) (local estimated flops for the elimination after factorization): [0] 932479. [1] 869485. 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] 544 [1] 512 RINFOG(1) (global estimated flops for the elimination after analysis): 1.80196e+06 RINFOG(2) (global estimated flops for the assembly after factorization): 66622. RINFOG(3) (global estimated flops for the elimination after factorization): 1.80196e+06 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 51008 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 12612 INFOG(5) (estimated maximum front size in the complete tree): 73 INFOG(6) (number of nodes in the complete tree): 277 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): 51008 INFOG(10) (total integer space store the matrix factors after factorization): 12612 INFOG(11) (order of largest frontal matrix after factorization): 73 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): 51008 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)): 51008 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=1056, cols=1056 total: nonzeros=7264, allocated nonzeros=7264 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines TC = 2.00000 TC = 2.00000 KSP Object: 2 MPI processes type: bcgs maximum iterations=10000000 tolerances: relative=3e-15, absolute=3e-15, divergence=10000. left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=2112, cols=2112, bs=2 total: nonzeros=29056, allocated nonzeros=29056 total number of mallocs used during MatSetValues calls =0 using I-node (on process 0) routines: found 531 nodes, limit used is 5 KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=4160, cols=4160 package used to perform factorization: mumps total: nonzeros=308450, allocated nonzeros=308450 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 8.38453e+06 [1] 1.25452e+07 RINFO(2) (local estimated flops for the assembly after factorization): [0] 182266. [1] 301283. RINFO(3) (local estimated flops for the elimination after factorization): [0] 8.38453e+06 [1] 1.25452e+07 INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 6 [1] 7 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 6 [1] 7 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 1736 [1] 2424 RINFOG(1) (global estimated flops for the elimination after analysis): 2.09297e+07 RINFOG(2) (global estimated flops for the assembly after factorization): 483549. RINFOG(3) (global estimated flops for the elimination after factorization): 2.09297e+07 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 308450 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 49482 INFOG(5) (estimated maximum front size in the complete tree): 167 INFOG(6) (number of nodes in the complete tree): 881 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): 308450 INFOG(10) (total integer space store the matrix factors after factorization): 49482 INFOG(11) (order of largest frontal matrix after factorization): 167 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): 7 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 13 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 13 INFOG(20) (estimated number of entries in the factors): 308450 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 6 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 12 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)): 308450 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 4 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=4160, cols=4160 total: nonzeros=47360, allocated nonzeros=47360 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=1056, cols=1056 package used to perform factorization: mumps total: nonzeros=51008, allocated nonzeros=51008 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 932479. [1] 869485. RINFO(2) (local estimated flops for the assembly after factorization): [0] 34069. [1] 32553. RINFO(3) (local estimated flops for the elimination after factorization): [0] 932479. [1] 869485. 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] 544 [1] 512 RINFOG(1) (global estimated flops for the elimination after analysis): 1.80196e+06 RINFOG(2) (global estimated flops for the assembly after factorization): 66622. RINFOG(3) (global estimated flops for the elimination after factorization): 1.80196e+06 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 51008 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 12612 INFOG(5) (estimated maximum front size in the complete tree): 73 INFOG(6) (number of nodes in the complete tree): 277 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): 51008 INFOG(10) (total integer space store the matrix factors after factorization): 12612 INFOG(11) (order of largest frontal matrix after factorization): 73 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): 51008 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)): 51008 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=1056, cols=1056 total: nonzeros=7264, allocated nonzeros=7264 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines TC = 2.50000 TC = 2.50000 KSP Object: 2 MPI processes type: bcgs maximum iterations=10000000 tolerances: relative=3e-15, absolute=3e-15, divergence=10000. left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=2112, cols=2112, bs=2 total: nonzeros=29056, allocated nonzeros=29056 total number of mallocs used during MatSetValues calls =0 using I-node (on process 0) routines: found 531 nodes, limit used is 5 KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=4160, cols=4160 package used to perform factorization: mumps total: nonzeros=308450, allocated nonzeros=308450 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 8.38453e+06 [1] 1.25452e+07 RINFO(2) (local estimated flops for the assembly after factorization): [0] 182266. [1] 301283. RINFO(3) (local estimated flops for the elimination after factorization): [0] 8.38453e+06 [1] 1.25452e+07 INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 6 [1] 7 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 6 [1] 7 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 1736 [1] 2424 RINFOG(1) (global estimated flops for the elimination after analysis): 2.09297e+07 RINFOG(2) (global estimated flops for the assembly after factorization): 483549. RINFOG(3) (global estimated flops for the elimination after factorization): 2.09297e+07 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 308450 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 49482 INFOG(5) (estimated maximum front size in the complete tree): 167 INFOG(6) (number of nodes in the complete tree): 881 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): 308450 INFOG(10) (total integer space store the matrix factors after factorization): 49482 INFOG(11) (order of largest frontal matrix after factorization): 167 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): 7 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 13 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 13 INFOG(20) (estimated number of entries in the factors): 308450 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 6 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 12 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)): 308450 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 4 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=4160, cols=4160 total: nonzeros=47360, allocated nonzeros=47360 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=1056, cols=1056 package used to perform factorization: mumps total: nonzeros=51008, allocated nonzeros=51008 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 932479. [1] 869485. RINFO(2) (local estimated flops for the assembly after factorization): [0] 34069. [1] 32553. RINFO(3) (local estimated flops for the elimination after factorization): [0] 932479. [1] 869485. 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] 544 [1] 512 RINFOG(1) (global estimated flops for the elimination after analysis): 1.80196e+06 RINFOG(2) (global estimated flops for the assembly after factorization): 66622. RINFOG(3) (global estimated flops for the elimination after factorization): 1.80196e+06 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 51008 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 12612 INFOG(5) (estimated maximum front size in the complete tree): 73 INFOG(6) (number of nodes in the complete tree): 277 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): 51008 INFOG(10) (total integer space store the matrix factors after factorization): 12612 INFOG(11) (order of largest frontal matrix after factorization): 73 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): 51008 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)): 51008 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=1056, cols=1056 total: nonzeros=7264, allocated nonzeros=7264 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines TC = 3.00000 TC = 3.00000 KSP Object: 2 MPI processes type: bcgs maximum iterations=10000000 tolerances: relative=3e-15, absolute=3e-15, divergence=10000. left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=2112, cols=2112, bs=2 total: nonzeros=29056, allocated nonzeros=29056 total number of mallocs used during MatSetValues calls =0 using I-node (on process 0) routines: found 531 nodes, limit used is 5 KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=4160, cols=4160 package used to perform factorization: mumps total: nonzeros=308450, allocated nonzeros=308450 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 8.38453e+06 [1] 1.25452e+07 RINFO(2) (local estimated flops for the assembly after factorization): [0] 182266. [1] 301283. RINFO(3) (local estimated flops for the elimination after factorization): [0] 8.38453e+06 [1] 1.25452e+07 INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 6 [1] 7 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 6 [1] 7 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 1736 [1] 2424 RINFOG(1) (global estimated flops for the elimination after analysis): 2.09297e+07 RINFOG(2) (global estimated flops for the assembly after factorization): 483549. RINFOG(3) (global estimated flops for the elimination after factorization): 2.09297e+07 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 308450 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 49482 INFOG(5) (estimated maximum front size in the complete tree): 167 INFOG(6) (number of nodes in the complete tree): 881 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): 308450 INFOG(10) (total integer space store the matrix factors after factorization): 49482 INFOG(11) (order of largest frontal matrix after factorization): 167 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): 7 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 13 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 13 INFOG(20) (estimated number of entries in the factors): 308450 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 6 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 12 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)): 308450 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 4 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=4160, cols=4160 total: nonzeros=47360, allocated nonzeros=47360 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=1056, cols=1056 package used to perform factorization: mumps total: nonzeros=51008, allocated nonzeros=51008 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 932479. [1] 869485. RINFO(2) (local estimated flops for the assembly after factorization): [0] 34069. [1] 32553. RINFO(3) (local estimated flops for the elimination after factorization): [0] 932479. [1] 869485. 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] 544 [1] 512 RINFOG(1) (global estimated flops for the elimination after analysis): 1.80196e+06 RINFOG(2) (global estimated flops for the assembly after factorization): 66622. RINFOG(3) (global estimated flops for the elimination after factorization): 1.80196e+06 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 51008 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 12612 INFOG(5) (estimated maximum front size in the complete tree): 73 INFOG(6) (number of nodes in the complete tree): 277 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): 51008 INFOG(10) (total integer space store the matrix factors after factorization): 12612 INFOG(11) (order of largest frontal matrix after factorization): 73 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): 51008 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)): 51008 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=1056, cols=1056 total: nonzeros=7264, allocated nonzeros=7264 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines TC = 3.50000 TC = 3.50000 KSP Object: 2 MPI processes type: bcgs maximum iterations=10000000 tolerances: relative=3e-15, absolute=3e-15, divergence=10000. left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=2112, cols=2112, bs=2 total: nonzeros=29056, allocated nonzeros=29056 total number of mallocs used during MatSetValues calls =0 using I-node (on process 0) routines: found 531 nodes, limit used is 5 KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=4160, cols=4160 package used to perform factorization: mumps total: nonzeros=308450, allocated nonzeros=308450 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 8.38453e+06 [1] 1.25452e+07 RINFO(2) (local estimated flops for the assembly after factorization): [0] 182266. [1] 301283. RINFO(3) (local estimated flops for the elimination after factorization): [0] 8.38453e+06 [1] 1.25452e+07 INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 6 [1] 7 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 6 [1] 7 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 1736 [1] 2424 RINFOG(1) (global estimated flops for the elimination after analysis): 2.09297e+07 RINFOG(2) (global estimated flops for the assembly after factorization): 483549. RINFOG(3) (global estimated flops for the elimination after factorization): 2.09297e+07 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 308450 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 49482 INFOG(5) (estimated maximum front size in the complete tree): 167 INFOG(6) (number of nodes in the complete tree): 881 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): 308450 INFOG(10) (total integer space store the matrix factors after factorization): 49482 INFOG(11) (order of largest frontal matrix after factorization): 167 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): 7 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 13 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 13 INFOG(20) (estimated number of entries in the factors): 308450 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 6 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 12 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)): 308450 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 4 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=4160, cols=4160 total: nonzeros=47360, allocated nonzeros=47360 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=1056, cols=1056 package used to perform factorization: mumps total: nonzeros=51008, allocated nonzeros=51008 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 932479. [1] 869485. RINFO(2) (local estimated flops for the assembly after factorization): [0] 34069. [1] 32553. RINFO(3) (local estimated flops for the elimination after factorization): [0] 932479. [1] 869485. 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] 544 [1] 512 RINFOG(1) (global estimated flops for the elimination after analysis): 1.80196e+06 RINFOG(2) (global estimated flops for the assembly after factorization): 66622. RINFOG(3) (global estimated flops for the elimination after factorization): 1.80196e+06 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 51008 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 12612 INFOG(5) (estimated maximum front size in the complete tree): 73 INFOG(6) (number of nodes in the complete tree): 277 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): 51008 INFOG(10) (total integer space store the matrix factors after factorization): 12612 INFOG(11) (order of largest frontal matrix after factorization): 73 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): 51008 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)): 51008 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=1056, cols=1056 total: nonzeros=7264, allocated nonzeros=7264 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines TC = 4.00000 TC = 4.00000 KSP Object: 2 MPI processes type: bcgs maximum iterations=10000000 tolerances: relative=3e-15, absolute=3e-15, divergence=10000. left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=2112, cols=2112, bs=2 total: nonzeros=29056, allocated nonzeros=29056 total number of mallocs used during MatSetValues calls =0 using I-node (on process 0) routines: found 531 nodes, limit used is 5 KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=4160, cols=4160 package used to perform factorization: mumps total: nonzeros=308450, allocated nonzeros=308450 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 8.38453e+06 [1] 1.25452e+07 RINFO(2) (local estimated flops for the assembly after factorization): [0] 182266. [1] 301283. RINFO(3) (local estimated flops for the elimination after factorization): [0] 8.38453e+06 [1] 1.25452e+07 INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 6 [1] 7 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 6 [1] 7 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 1736 [1] 2424 RINFOG(1) (global estimated flops for the elimination after analysis): 2.09297e+07 RINFOG(2) (global estimated flops for the assembly after factorization): 483549. RINFOG(3) (global estimated flops for the elimination after factorization): 2.09297e+07 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 308450 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 49482 INFOG(5) (estimated maximum front size in the complete tree): 167 INFOG(6) (number of nodes in the complete tree): 881 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): 308450 INFOG(10) (total integer space store the matrix factors after factorization): 49482 INFOG(11) (order of largest frontal matrix after factorization): 167 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): 7 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 13 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 13 INFOG(20) (estimated number of entries in the factors): 308450 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 6 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 12 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)): 308450 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 4 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=4160, cols=4160 total: nonzeros=47360, allocated nonzeros=47360 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=1056, cols=1056 package used to perform factorization: mumps total: nonzeros=51008, allocated nonzeros=51008 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 932479. [1] 869485. RINFO(2) (local estimated flops for the assembly after factorization): [0] 34069. [1] 32553. RINFO(3) (local estimated flops for the elimination after factorization): [0] 932479. [1] 869485. 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] 544 [1] 512 RINFOG(1) (global estimated flops for the elimination after analysis): 1.80196e+06 RINFOG(2) (global estimated flops for the assembly after factorization): 66622. RINFOG(3) (global estimated flops for the elimination after factorization): 1.80196e+06 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 51008 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 12612 INFOG(5) (estimated maximum front size in the complete tree): 73 INFOG(6) (number of nodes in the complete tree): 277 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): 51008 INFOG(10) (total integer space store the matrix factors after factorization): 12612 INFOG(11) (order of largest frontal matrix after factorization): 73 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): 51008 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)): 51008 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=1056, cols=1056 total: nonzeros=7264, allocated nonzeros=7264 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines TC = 4.50000 TC = 4.50000 KSP Object: 2 MPI processes type: bcgs maximum iterations=10000000 tolerances: relative=3e-15, absolute=3e-15, divergence=10000. left preconditioning using nonzero initial guess using PRECONDITIONED norm type for convergence test PC Object: 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=2112, cols=2112, bs=2 total: nonzeros=29056, allocated nonzeros=29056 total number of mallocs used during MatSetValues calls =0 using I-node (on process 0) routines: found 531 nodes, limit used is 5 KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=4160, cols=4160 package used to perform factorization: mumps total: nonzeros=308450, allocated nonzeros=308450 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 8.38453e+06 [1] 1.25452e+07 RINFO(2) (local estimated flops for the assembly after factorization): [0] 182266. [1] 301283. RINFO(3) (local estimated flops for the elimination after factorization): [0] 8.38453e+06 [1] 1.25452e+07 INFO(15) (estimated size of (in MB) MUMPS internal data for running numerical factorization): [0] 6 [1] 7 INFO(16) (size of (in MB) MUMPS internal data used during numerical factorization): [0] 6 [1] 7 INFO(23) (num of pivots eliminated on this processor after factorization): [0] 1736 [1] 2424 RINFOG(1) (global estimated flops for the elimination after analysis): 2.09297e+07 RINFOG(2) (global estimated flops for the assembly after factorization): 483549. RINFOG(3) (global estimated flops for the elimination after factorization): 2.09297e+07 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 308450 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 49482 INFOG(5) (estimated maximum front size in the complete tree): 167 INFOG(6) (number of nodes in the complete tree): 881 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): 308450 INFOG(10) (total integer space store the matrix factors after factorization): 49482 INFOG(11) (order of largest frontal matrix after factorization): 167 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): 7 INFOG(17) (estimated size of all MUMPS internal data for factorization after analysis: sum over all processors): 13 INFOG(18) (size of all MUMPS internal data allocated during factorization: value on the most memory consuming processor): 7 INFOG(19) (size of all MUMPS internal data allocated during factorization: sum over all processors): 13 INFOG(20) (estimated number of entries in the factors): 308450 INFOG(21) (size in MB of memory effectively used during factorization - value on the most memory consuming processor): 6 INFOG(22) (size in MB of memory effectively used during factorization - sum over all processors): 12 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)): 308450 INFOG(30, 31) (after solution: size in Mbytes of memory used during solution phase): 2, 4 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=4160, cols=4160 total: nonzeros=47360, allocated nonzeros=47360 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines KSP Object: 2 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: 2 MPI processes type: lu 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: mpiaij rows=1056, cols=1056 package used to perform factorization: mumps total: nonzeros=51008, allocated nonzeros=51008 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) (sequentia matrix ordering):7 ICNTL(8) (scalling 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) (Shur 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): -8 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 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. RINFO(1) (local estimated flops for the elimination after analysis): [0] 932479. [1] 869485. RINFO(2) (local estimated flops for the assembly after factorization): [0] 34069. [1] 32553. RINFO(3) (local estimated flops for the elimination after factorization): [0] 932479. [1] 869485. 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] 544 [1] 512 RINFOG(1) (global estimated flops for the elimination after analysis): 1.80196e+06 RINFOG(2) (global estimated flops for the assembly after factorization): 66622. RINFOG(3) (global estimated flops for the elimination after factorization): 1.80196e+06 (RINFOG(12) RINFOG(13))*2^INFOG(34) (determinant): (0.,0.)*(2^0) INFOG(3) (estimated real workspace for factors on all processors after analysis): 51008 INFOG(4) (estimated integer workspace for factors on all processors after analysis): 12612 INFOG(5) (estimated maximum front size in the complete tree): 73 INFOG(6) (number of nodes in the complete tree): 277 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): 51008 INFOG(10) (total integer space store the matrix factors after factorization): 12612 INFOG(11) (order of largest frontal matrix after factorization): 73 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): 51008 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)): 51008 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=1056, cols=1056 total: nonzeros=7264, allocated nonzeros=7264 total number of mallocs used during MatSetValues calls =0 not using I-node (on process 0) routines TC = 5.00000 TC = 5.00000 From bsmith at mcs.anl.gov Wed Jul 12 14:59:42 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 12 Jul 2017 14:59:42 -0500 Subject: [petsc-users] NULL section fortran In-Reply-To: <1499889127627.57606@auckland.ac.nz> References: <1499889127627.57606@auckland.ac.nz> Message-ID: Matt needs to add something like PetscSection, parameter :: PETSC_NULL_SECTION = tPetscSection(-1) PetscSectionSym, parameter :: PETSC_NULL_SECTIONSYM = tPetscSectionSym(-1) to src/vec/f90-mod/petscis.h in the master branch. Barry > On Jul 12, 2017, at 2:52 PM, Justin Pogacnik wrote: > > Hello, > > I'm assembling a global finite element stiffness matrix and using the DMPlexMatSetClosure command in fortran. Long ago, in the past, I've used to set the section input parameters to PETSC_NULL_OBJECT. That now returns an error -- no implicit type -- during compilation. Looking at the defined null objects for fortran I don't see a section option. What should I use to invoke the default sections? > > Hope this makes sense. Thanks! > > Justin From bsmith at mcs.anl.gov Wed Jul 12 15:04:36 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 12 Jul 2017 15:04:36 -0500 Subject: [petsc-users] Rectangular matrices turned into square? In-Reply-To: References: <5EF4584F-BD6E-4F6D-9A5F-DD174FE3E204@mcs.anl.gov> Message-ID: <8FCC2FBF-9776-4A96-A635-B8A9C9C6C075@mcs.anl.gov> Are you talking about the below? If so, I suspect that the code is actually generating a square matrix, not a rectangular one. Hypre definitely cannot handle rectangular matrices. Barry PC Object: 2 MPI processes type: hypre HYPRE BoomerAMG preconditioning HYPRE BoomerAMG: Cycle type V HYPRE BoomerAMG: Maximum number of levels 25 HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. HYPRE BoomerAMG: Threshold for strong coupling 0.25 HYPRE BoomerAMG: Interpolation truncation factor 0. HYPRE BoomerAMG: Interpolation: max elements per row 0 HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 HYPRE BoomerAMG: Maximum row sums 0.9 HYPRE BoomerAMG: Sweeps down 1 HYPRE BoomerAMG: Sweeps up 1 HYPRE BoomerAMG: Sweeps on coarse 1 HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi HYPRE BoomerAMG: Relax on coarse Gaussian-elimination HYPRE BoomerAMG: Relax weight (all) 1. HYPRE BoomerAMG: Outer relax weight (all) 1. HYPRE BoomerAMG: Using CF-relaxation HYPRE BoomerAMG: Not using more complex smoothers. HYPRE BoomerAMG: Measure type local HYPRE BoomerAMG: Coarsen type Falgout HYPRE BoomerAMG: Interpolation type classical linear system matrix = precond matrix: Mat Object: 2 MPI processes type: mpiaij rows=2112, cols=2112, bs=2 total: nonzeros=29056, allocated nonzeros=29056 total number of mallocs used during MatSetValues calls =0 using I-node (on process 0) routines: found 531 nodes, limit used is 5 > On Jul 12, 2017, at 2:55 PM, Adam Denchfield wrote: > > Hi, > Below I've attached the text file with my ksp_view. It's a time-dependent problem so I included ten time-steps. The information doesn't seem to be much different in the multiple time steps. > > ______________ > > > > Regards, > Adam Denchfield > Peer Career Coach - Career Services > Illinois Institute of Technology > Bachelors of Science in Applied Physics (2018) > Email: adenchfi at hawk.iit.edu > My LinkedIn My ResearchGate Profile > > On Wed, Jul 12, 2017 at 2:48 PM, Barry Smith wrote: > > Adam, > > Please send the output from KSP view. We don't "change" the matrix but we might have some intermediate matrix of that other side, or it could be a bug in our output. > > Barry > > > On Jul 12, 2017, at 2:45 PM, Adam Denchfield wrote: > > > > Hi, > > > > I'm using the FEniCS package, which uses DOLFIN/petsc4py (and thus petsc). If I'm understanding the libraries right, I'm assembling rectangular matrices and sending them to be solved in a KrylovSolver. However, with -ksp_view, I'm seeing 2112x2112 matrices, not 1062x2112 matrices. Does PETSc do conversions like this automatically during preconditioning or something? Trying to identify if this would be a behaviour on PETSc's part. > > > > Regards, > > Adam Denchfield > > Peer Career Coach - Career Services > > Illinois Institute of Technology > > Bachelors of Science in Applied Physics (2018) > > Email: adenchfi at hawk.iit.edu > > My LinkedIn My ResearchGate Profile > > > From spandey2 at wpi.edu Wed Jul 12 15:05:21 2017 From: spandey2 at wpi.edu (Pandey, Siddhant) Date: Wed, 12 Jul 2017 20:05:21 +0000 Subject: [petsc-users] SLEPC solvers not converging in latest version In-Reply-To: <11AC9CF4-DE0D-4A46-B8F0-618C005E70A5@dsic.upv.es> References: , <11AC9CF4-DE0D-4A46-B8F0-618C005E70A5@dsic.upv.es> Message-ID: I've attached the B matrix (binary) in a zip file. To give more context to the problem, the previous installation of petsc/slecp doesn't give this error. So the matrix being singular shouldn't be the issue since my matrix assembly routines are independent of the petsc/slepc installation I use. Also, diagonalization happens for smaller matrices. Unfortunately, since EPSsolve never got completed, -eps_viewer didn't return anything. Is there any other way I can show the settings used? Sidd ________________________________ From: Jose E. Roman Sent: Wednesday, July 12, 2017 2:02:55 PM To: Hong Zhang Cc: petsc-users at mcs.anl.gov; Pandey, Siddhant Subject: Re: [petsc-users] SLEPC solvers not converging in latest version Let me correct my last message: we set this option in the development version (master), so yes, in 3.7 it may be good to try -ksp_error_if_not_converged Sorry for the noise. Jose > El 12 jul 2017, a las 19:58, Jose E. Roman escribi?: > > Hong: in the latests versions of SLEPc we turn on this option by default (except in some solvers such as JD), so I don't think the problem is in the KSP solve. > Jose > > >> El 12 jul 2017, a las 19:53, Hong escribi?: >> >> Add option '-ksp_error_if_not_converged'. I suspect the matrix has zero pivot. >> Hong >> >> On Wed, Jul 12, 2017 at 12:45 PM, Jose E. Roman wrote: >> >>> El 12 jul 2017, a las 18:56, Pandey, Siddhant escribi?: >>> >>> We recently updated our installation of PETSC and SLEPC from an older version, and eigenvalue problems converging in the previous installation is not converging anymore (diagonalization never comes to an end). On using -info, the following message keeps repeating during diagonalization: >>> >>> [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged >>> [0] STMatSolve(): Linear solve iterations=1 >>> [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged >>> [0] STMatSolve(): Linear solve iterations=1 >>> [0] BV_SafeSqrt(): Zero norm, either the vector is zero or a semi-inner product is being used >>> [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged >>> [0] STMatSolve(): Linear solve iterations=1 >>> [0] PCSetUp(): Leaving PC with identical preconditioner since operator is unchanged >>> [0] STMatSolve(): Linear solve iterations=1 >>> >>> As can be seen, iteration number remains 1. The issue gets resolved with a smaller sized matrix. Currently I am using a 10648 x 10648 matrix, and PETSC is configured for complex values. >>> >>> What changes do I have to make to make my codes work in the new installation? This seems to be a version specific issue. >>> >>> >>> Thanks, >>> Sidd >>> WPI >> >> I don't understand why are you getting the BV message. Maybe your B-matrix is singular, but it is not sufficient to explain this. If possible, send me your matrices and I will try to reproduce the problem (I would also need to know all the settings, which can be displayed with -eps_view or -eps_view_pre). >> >> Jose >> >> > -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: B_mat_binary.zip Type: application/zip Size: 853677 bytes Desc: B_mat_binary.zip URL: From adenchfi at hawk.iit.edu Wed Jul 12 15:11:51 2017 From: adenchfi at hawk.iit.edu (Adam Denchfield) Date: Wed, 12 Jul 2017 15:11:51 -0500 Subject: [petsc-users] Rectangular matrices turned into square? In-Reply-To: <8FCC2FBF-9776-4A96-A635-B8A9C9C6C075@mcs.anl.gov> References: <5EF4584F-BD6E-4F6D-9A5F-DD174FE3E204@mcs.anl.gov> <8FCC2FBF-9776-4A96-A635-B8A9C9C6C075@mcs.anl.gov> Message-ID: Hi, You're absolutely right. It turns out I was not saving my data properly when running the program in parallel. Thanks for checking! Regards, *Adam Denchfield* *Peer Career Coach - Career Services* Illinois Institute of Technology *Bachelors of Science in Applied Physics (2018)* Email: adenchfi at hawk.iit.edu My LinkedIn My ResearchGate Profile On Wed, Jul 12, 2017 at 3:04 PM, Barry Smith wrote: > > Are you talking about the below? If so, I suspect that the code is > actually generating a square matrix, not a rectangular one. Hypre > definitely cannot handle rectangular matrices. > > Barry > > > > PC Object: 2 MPI processes > type: hypre > HYPRE BoomerAMG preconditioning > HYPRE BoomerAMG: Cycle type V > HYPRE BoomerAMG: Maximum number of levels 25 > HYPRE BoomerAMG: Maximum number of iterations PER hypre call 1 > HYPRE BoomerAMG: Convergence tolerance PER hypre call 0. > HYPRE BoomerAMG: Threshold for strong coupling 0.25 > HYPRE BoomerAMG: Interpolation truncation factor 0. > HYPRE BoomerAMG: Interpolation: max elements per row 0 > HYPRE BoomerAMG: Number of levels of aggressive coarsening 0 > HYPRE BoomerAMG: Number of paths for aggressive coarsening 1 > HYPRE BoomerAMG: Maximum row sums 0.9 > HYPRE BoomerAMG: Sweeps down 1 > HYPRE BoomerAMG: Sweeps up 1 > HYPRE BoomerAMG: Sweeps on coarse 1 > HYPRE BoomerAMG: Relax down symmetric-SOR/Jacobi > HYPRE BoomerAMG: Relax up symmetric-SOR/Jacobi > HYPRE BoomerAMG: Relax on coarse Gaussian-elimination > HYPRE BoomerAMG: Relax weight (all) 1. > HYPRE BoomerAMG: Outer relax weight (all) 1. > HYPRE BoomerAMG: Using CF-relaxation > HYPRE BoomerAMG: Not using more complex smoothers. > HYPRE BoomerAMG: Measure type local > HYPRE BoomerAMG: Coarsen type Falgout > HYPRE BoomerAMG: Interpolation type classical > linear system matrix = precond matrix: > Mat Object: 2 MPI processes > type: mpiaij > rows=2112, cols=2112, bs=2 > total: nonzeros=29056, allocated nonzeros=29056 > total number of mallocs used during MatSetValues calls =0 > using I-node (on process 0) routines: found 531 nodes, limit used is > 5 > > > On Jul 12, 2017, at 2:55 PM, Adam Denchfield > wrote: > > > > Hi, > > Below I've attached the text file with my ksp_view. It's a > time-dependent problem so I included ten time-steps. The information > doesn't seem to be much different in the multiple time steps. > > > > ______________ > > > > > > > > Regards, > > Adam Denchfield > > Peer Career Coach - Career Services > > Illinois Institute of Technology > > Bachelors of Science in Applied Physics (2018) > > Email: adenchfi at hawk.iit.edu > > My LinkedIn My ResearchGate Profile > > > > On Wed, Jul 12, 2017 at 2:48 PM, Barry Smith wrote: > > > > Adam, > > > > Please send the output from KSP view. We don't "change" the matrix > but we might have some intermediate matrix of that other side, or it could > be a bug in our output. > > > > Barry > > > > > On Jul 12, 2017, at 2:45 PM, Adam Denchfield > wrote: > > > > > > Hi, > > > > > > I'm using the FEniCS package, which uses DOLFIN/petsc4py (and thus > petsc). If I'm understanding the libraries right, I'm assembling > rectangular matrices and sending them to be solved in a KrylovSolver. > However, with -ksp_view, I'm seeing 2112x2112 matrices, not 1062x2112 > matrices. Does PETSc do conversions like this automatically during > preconditioning or something? Trying to identify if this would be a > behaviour on PETSc's part. > > > > > > Regards, > > > Adam Denchfield > > > Peer Career Coach - Career Services > > > Illinois Institute of Technology > > > Bachelors of Science in Applied Physics (2018) > > > Email: adenchfi at hawk.iit.edu > > > My LinkedIn My ResearchGate Profile > > > > > > > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jroman at dsic.upv.es Wed Jul 12 15:29:57 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Wed, 12 Jul 2017 22:29:57 +0200 Subject: [petsc-users] SLEPC solvers not converging in latest version In-Reply-To: References: <11AC9CF4-DE0D-4A46-B8F0-618C005E70A5@dsic.upv.es> Message-ID: > El 12 jul 2017, a las 22:05, Pandey, Siddhant escribi?: > > I've attached the B matrix (binary) in a zip file. To give more context to the problem, the previous installation of petsc/slecp doesn't give this error. So the matrix being singular shouldn't be the issue since my matrix assembly routines are independent of the petsc/slepc installation I use. Also, diagonalization happens for smaller matrices. > > Unfortunately, since EPSsolve never got completed, -eps_viewer didn't return anything. Is there any other way I can show the settings used? > > Sidd Use -eps_view_pre (it should view settings at the beginning of solve), or run a smaller case (settings should be the same). I will also need the other matrix, otherwise I cannot run EPS. Also, tell me which version are you using now, and which version worked before. Jose From spandey2 at wpi.edu Wed Jul 12 16:15:36 2017 From: spandey2 at wpi.edu (Pandey, Siddhant) Date: Wed, 12 Jul 2017 21:15:36 +0000 Subject: [petsc-users] SLEPC solvers not converging in latest version In-Reply-To: References: <11AC9CF4-DE0D-4A46-B8F0-618C005E70A5@dsic.upv.es> , Message-ID: I have attached the matrices and the 'eps_view_pre' ouput in the zip file. The versions of the older installation were: petsc-3.7.5, slecp-3.7.1; and the current versions are: petsc-3.7.6, slecp-3.7.4. Thanks, Sidd (WPI) ________________________________ From: Jose E. Roman Sent: Wednesday, July 12, 2017 4:29:57 PM To: Pandey, Siddhant Cc: Hong Zhang; petsc-users at mcs.anl.gov Subject: Re: [petsc-users] SLEPC solvers not converging in latest version > El 12 jul 2017, a las 22:05, Pandey, Siddhant escribi?: > > I've attached the B matrix (binary) in a zip file. To give more context to the problem, the previous installation of petsc/slecp doesn't give this error. So the matrix being singular shouldn't be the issue since my matrix assembly routines are independent of the petsc/slepc installation I use. Also, diagonalization happens for smaller matrices. > > Unfortunately, since EPSsolve never got completed, -eps_viewer didn't return anything. Is there any other way I can show the settings used? > > Sidd Use -eps_view_pre (it should view settings at the beginning of solve), or run a smaller case (settings should be the same). I will also need the other matrix, otherwise I cannot run EPS. Also, tell me which version are you using now, and which version worked before. Jose -------------- next part -------------- An HTML attachment was scrubbed... URL: -------------- next part -------------- A non-text attachment was scrubbed... Name: A,B,eps.zip Type: application/zip Size: 1724770 bytes Desc: A,B,eps.zip URL: From jroman at dsic.upv.es Thu Jul 13 06:28:57 2017 From: jroman at dsic.upv.es (Jose E. Roman) Date: Thu, 13 Jul 2017 13:28:57 +0200 Subject: [petsc-users] SLEPC solvers not converging in latest version In-Reply-To: References: <11AC9CF4-DE0D-4A46-B8F0-618C005E70A5@dsic.upv.es> Message-ID: <4F597AB8-EC7A-479D-B180-91A036905357@dsic.upv.es> Sidd, I don't know why you are getting different behaviour in the current and older installations. There is no substantial difference between slepc-3.7.1 and slepc-3.7.4 in the parts you are using. Anyway, computing smallest_magnitude eigenvalues in a generalized eigenproblem is a bad idea, it is much better to compute largest eigenvalues, either swapping the matrices, or using shift-and-invert with sigma=0. Below you can see the output I get. This strategy should be more robust and I would bet the problem you report will not appear. $ mpiexec -n 1 ./ex7 -f1 A_mat_binary -f2 B_mat_binary -eps_gen_hermitian -eps_nev 50 -eps_ncv 100 -eps_tol 1e-12 -st_pc_factor_mat_solver_package mumps -eps_monitor -st_type sinvert -eps_target 0 Generalized eigenproblem stored in file. Reading COMPLEX matrices from binary files... 1 EPS nconv=11 first unconverged value (error) 0.0131612+0i (8.75138656e-12) 2 EPS nconv=11 first unconverged value (error) 0.0131612+0i (1.12729823e-12) 3 EPS nconv=31 first unconverged value (error) 0.0197448+0i (6.83423520e-03) 4 EPS nconv=40 first unconverged value (error) 0.0244434+0i (1.36991619e-12) 5 EPS nconv=40 first unconverged value (error) 0.0244434+0i (1.64341819e-11) 6 EPS nconv=49 first unconverged value (error) 0.0272636+0i (2.53225772e-12) 7 EPS nconv=73 first unconverged value (error) 0.0338452+0i (1.02615547e-07) Number of iterations of the method: 7 Number of linear iterations of the method: 312 Solution method: krylovschur Number of requested eigenvalues: 50 Stopping condition: tol=1e-12, maxit=212 Linear eigensolve converged (73 eigenpairs) due to CONVERGED_TOL; iterations 7 ---------------------- -------------------- k ||Ax-kBx||/||kx|| ---------------------- -------------------- 0.002820 1.11732e-12 0.005640 8.2307e-13 0.005640 6.28498e-13 0.005640 1.33386e-12 0.008461 1.66237e-12 0.008461 6.73195e-13 0.008461 5.51759e-13 0.010341 4.572e-13 0.010341 4.71274e-13 0.010341 5.66704e-13 0.011281 5.64244e-13 0.013161 6.26089e-13 0.013161 5.68378e-13 0.013161 6.06859e-13 0.013161 5.14892e-13 0.013161 4.86807e-13 0.013161 7.12961e-13 0.015981 7.21151e-13 0.015981 6.6669e-13 0.015981 6.95718e-13 0.016923 7.27843e-13 0.016923 5.9206e-13 0.016923 9.19785e-13 0.017862 6.79618e-13 0.017862 6.86632e-13 0.017862 8.48137e-13 0.019743 1.73846e-12 0.019743 1.03895e-12 0.019743 7.29832e-13 0.019743 9.52146e-13 0.019743 6.08032e-13 0.019743 8.11897e-13 0.020682 8.97699e-13 0.020682 8.84601e-13 0.020682 5.55719e-13 0.022563 5.86552e-13 0.022563 5.27907e-13 0.022563 5.43232e-13 0.024443 4.99962e-13 0.024443 9.92323e-13 0.024443 6.195e-13 0.024443 5.15713e-13 0.024443 7.09306e-13 0.024443 6.86883e-13 0.025382 9.61258e-13 0.025388 8.24511e-13 0.025388 6.1544e-13 0.025388 3.64722e-13 0.027264 8.3364e-11 0.027264 4.71596e-13 0.027264 8.76059e-13 0.027264 5.89152e-13 0.027264 1.38562e-12 0.027264 7.34739e-13 0.028208 8.70508e-13 0.028208 5.33376e-13 0.028208 1.41842e-10 0.028208 7.31921e-13 0.028208 9.3135e-13 0.028208 1.3238e-12 0.031025 8.70416e-13 0.031025 4.034e-13 0.031025 5.21825e-13 0.031029 5.07974e-13 0.031029 5.93828e-13 0.031029 8.67516e-13 0.031964 6.06749e-13 0.031964 1.26228e-12 0.031964 4.21629e-13 0.032909 4.91244e-12 0.032909 5.36743e-13 0.032909 1.46225e-12 0.032909 4.99251e-13 ---------------------- -------------------- > El 12 jul 2017, a las 23:15, Pandey, Siddhant escribi?: > > I have attached the matrices and the 'eps_view_pre' ouput in the zip file. > > The versions of the older installation were: petsc-3.7.5, slecp-3.7.1; > and the current versions are: petsc-3.7.6, slecp-3.7.4. > > > Thanks, > Sidd (WPI) > From: Jose E. Roman > Sent: Wednesday, July 12, 2017 4:29:57 PM > To: Pandey, Siddhant > Cc: Hong Zhang; petsc-users at mcs.anl.gov > Subject: Re: [petsc-users] SLEPC solvers not converging in latest version > > > > El 12 jul 2017, a las 22:05, Pandey, Siddhant escribi?: > > > > I've attached the B matrix (binary) in a zip file. To give more context to the problem, the previous installation of petsc/slecp doesn't give this error. So the matrix being singular shouldn't be the issue since my matrix assembly routines are independent of the petsc/slepc installation I use. Also, diagonalization happens for smaller matrices. > > > > Unfortunately, since EPSsolve never got completed, -eps_viewer didn't return anything. Is there any other way I can show the settings used? > > > > Sidd > > Use -eps_view_pre (it should view settings at the beginning of solve), or run a smaller case (settings should be the same). > > I will also need the other matrix, otherwise I cannot run EPS. > > Also, tell me which version are you using now, and which version worked before. > > Jose > > From mailinglists at xgm.de Sun Jul 16 21:26:29 2017 From: mailinglists at xgm.de (Florian Lindner) Date: Mon, 17 Jul 2017 10:26:29 +0800 Subject: [petsc-users] Understanding preallocation for MPI In-Reply-To: References: <3d7ca106-c1da-e9df-a7de-0b75aad2bad3@xgm.de> Message-ID: Hello, Am 11.07.2017 um 02:45 schrieb Barry Smith: > > You might consider using http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatPreallocateInitialize.html and http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatPreallocateSetLocal.html#MatPreallocateSetLocal and friends > > These take out some of the busywork of setting the preallocation arrays. They are macros in petscmat.h so even if you don't use them you can see the code they use. Thanks for your input, I took a look at it and learned from it. I have this preallocation routine which works perfectly for a index set on the columns and non (resp. an identity index set) on the columns: void doPreallocation(Mat &A, ISLocalToGlobalMapping &ISmapping, double nz_ratio, int nz_number) { PetscInt d_nnz[local_rows], o_nnz[local_rows]; const PetscInt *mapIndizes; ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); for (int row = row_range_start; row < row_range_end; row++) { // PetscInt relative_row = mapIndizes[row- row_range_start]; PetscInt relative_row = row - row_range_start; d_nnz[relative_row] = 0; o_nnz[relative_row] = 0; int colStart, colEnd; std::tie(colStart, colEnd) = colBorders(row); for (int col = 0; col < global_cols; col++) { if (col >= colStart and col < colEnd) { int petsc_col = mapIndizes[col]; if (petsc_col >= col_range_start and petsc_col < col_range_end) { d_nnz[relative_row]++; } else { o_nnz[relative_row]++; } } } } ierr = ISLocalToGlobalMappingRestoreIndices(ISmapping, &mapIndizes); CHKERRV(ierr); ierr = MatMPIAIJSetPreallocation(A, 0, d_nnz, 0, o_nnz); CHKERRV(ierr); // works only on minimum 2 ranks } colStart and colEnd give a defined number of diagonals for the matrix, just for testing. *_range_* are from the PETSc routines. But I'm puzzled how to do it when I have also a (the same) index set for the rows. Let's say I have 2 procs, a global size of 10 and a mapping [0, 8, 9, 1, 3] on proc 0 and [2, 5, 4, 7, 6] on proc 1. row_range is [0, 5] on the first proc. On the first row-iteration I generate data for row 0 (application ordering AO) which is mapped to row 0 (petsc ordering PO), I add these nnz to o_/d_nnz[0] On the second row-iteration I generate data for row 1 (AO) which is mapped to row 8 (PO). As with the columns I expect the nnz numbering to be in PO, which means either 1) nnz[8] (which is not existing), what I would be do in the commented out line. 2) nnz[4] on the second proc (which is unreachable from the first proc) 3) nnz[1] on the first proc, thus in AO, which produces new mallocs. 2. still seems to most probable for me, but before implementing sending the stuff around using MPI, I wanted to ask you if it is correct that way? If it needs to be done that way, is there some PETSc magic which helps exchanging that array? If the answer lies within MatPreallocate* routines, I failed to see :-/ Best Thanks, Florian >> On Jul 10, 2017, at 3:22 AM, Florian Lindner wrote: >> >> Hey, >> >> one more question about preallocation: >> >> I can determine if a column index is diagonal or off-diagonal using that code >> >> if (col >= col_range_start and col < col_range_end) >> d_nnz[relative_row]++; >> else >> o_nnz[relative_row]++; >> >> >> My code, however uses index sets from which a ISlocalToGlobalMapping created: >> >> // Creates a mapping from permutation and use that for the cols >> ierr = ISCreateGeneral(PETSC_COMM_WORLD, local_cols, permutation.data(), PETSC_COPY_VALUES, &ISlocal); CHKERRV(ierr); >> ierr = ISSetPermutation(ISlocal); CHKERRV(ierr); >> ierr = ISAllGather(ISlocal, &ISglobal); CHKERRV(ierr); // Gather the IS from all processors >> ierr = ISLocalToGlobalMappingCreateIS(ISglobal, &ISmapping); CHKERRV(ierr); // Make it a mapping >> >> // Create an identity mapping and use that for the rows of A. >> ierr = ISCreateStride(PETSC_COMM_WORLD, local_rows, row_range_start, 1, &ISidentity); CHKERRV(ierr); >> ierr = ISSetIdentity(ISidentity); CHKERRV(ierr); >> ierr = ISAllGather(ISidentity, &ISidentityGlobal); CHKERRV(ierr); >> ierr = ISLocalToGlobalMappingCreateIS(ISidentityGlobal, &ISidentityMapping); CHKERRV(ierr); >> >> ierr = MatSetLocalToGlobalMapping(A, ISidentityMapping, ISmapping); CHKERRV(ierr); >> >> since SetPreallocation routines define the diagonal / off-diagonal blocks from the petsc ordering, I have to translate >> the col to a petsc_col. >> >> What is the best / fastest way to do that? >> >> Is that the way to go? >> >> PetscInt mapSize; >> ISLocalToGlobalMappingGetSize(ISmapping, &mapSize); >> const PetscInt *mapIndizes; >> ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); >> >> Thanks, >> Florian >> >> >> >> Am 07.07.2017 um 17:31 schrieb Florian Lindner: >>> Hello, >>> >>> I'm having some struggle understanding the preallocation for MPIAIJ matrices, especially when a value is in off-diagonal >>> vs. diagonal block. >>> >>> The small example program is at https://pastebin.com/67dXnGm3 >>> >>> In general it should be parallel, but right now I just run it in serial. >>> >>> According to my understanding of >>> >>> http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/Mat/MatMPIAIJSetPreallocation.html >>> >>> a entry is in the diagonal submatrix, if its row is in the OwnershipRange and its column is in OwnershipRangeColumn. >>> That also means that in a serial run, there is only a diagonal submatrix. >>> >>> However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when >>> >>> Inserting 6 elements in row 2, though I have exactly >>> >>> 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal submatrix of row 2) >>> >>> Error is: >>> >>> [0]PETSC ERROR: Argument out of range >>> [0]PETSC ERROR: New nonzero at (2,5) caused a malloc >>> Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn off this check >>> >>> >>> What is wrong with my understanding? >>> >>> Thanks, >>> Florian >>> > From bsmith at mcs.anl.gov Sun Jul 16 21:42:10 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 16 Jul 2017 21:42:10 -0500 Subject: [petsc-users] Understanding preallocation for MPI In-Reply-To: References: <3d7ca106-c1da-e9df-a7de-0b75aad2bad3@xgm.de> Message-ID: <527F7048-58C3-466E-8E44-6C17E7B1D584@mcs.anl.gov> Florian, The intention with the AO is you map everything to the PETSc ordering and then you just work in the PETSc ordering completely, this way there is no "sending around with MPI preallocation information". That is your matrix assembly and preallocation (as well as vectors) always works in the PETSc numbering. In the PETSc ordering there is no need to send information between processes about row allocations since the information is always on the correct process. Barry > On Jul 16, 2017, at 9:26 PM, Florian Lindner wrote: > > Hello, > > Am 11.07.2017 um 02:45 schrieb Barry Smith: >> >> You might consider using http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatPreallocateInitialize.html and http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatPreallocateSetLocal.html#MatPreallocateSetLocal and friends >> >> These take out some of the busywork of setting the preallocation arrays. They are macros in petscmat.h so even if you don't use them you can see the code they use. > > Thanks for your input, I took a look at it and learned from it. > > I have this preallocation routine which works perfectly for a index set on the columns and non (resp. an identity index > set) on the columns: > > void doPreallocation(Mat &A, ISLocalToGlobalMapping &ISmapping, double nz_ratio, int nz_number) > { > PetscInt d_nnz[local_rows], o_nnz[local_rows]; > > const PetscInt *mapIndizes; > ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); > > for (int row = row_range_start; row < row_range_end; row++) { > // PetscInt relative_row = mapIndizes[row- row_range_start]; > PetscInt relative_row = row - row_range_start; > d_nnz[relative_row] = 0; > o_nnz[relative_row] = 0; > int colStart, colEnd; > std::tie(colStart, colEnd) = colBorders(row); > for (int col = 0; col < global_cols; col++) { > if (col >= colStart and col < colEnd) { > int petsc_col = mapIndizes[col]; > if (petsc_col >= col_range_start and petsc_col < col_range_end) { > d_nnz[relative_row]++; > } else { > o_nnz[relative_row]++; > } > } > } > } > ierr = ISLocalToGlobalMappingRestoreIndices(ISmapping, &mapIndizes); CHKERRV(ierr); > ierr = MatMPIAIJSetPreallocation(A, 0, d_nnz, 0, o_nnz); CHKERRV(ierr); // works only on minimum 2 ranks > } > > colStart and colEnd give a defined number of diagonals for the matrix, just for testing. *_range_* are from the PETSc > routines. > > But I'm puzzled how to do it when I have also a (the same) index set for the rows. > > Let's say I have 2 procs, a global size of 10 and a mapping [0, 8, 9, 1, 3] on proc 0 and [2, 5, 4, 7, 6] on proc 1. > > row_range is [0, 5] on the first proc. > > On the first row-iteration I generate data for row 0 (application ordering AO) which is mapped to row 0 (petsc ordering > PO), I add these nnz to o_/d_nnz[0] > > On the second row-iteration I generate data for row 1 (AO) which is mapped to row 8 (PO). As with the columns I expect > the nnz numbering to be in PO, which means either > > 1) nnz[8] (which is not existing), what I would be do in the commented out line. > 2) nnz[4] on the second proc (which is unreachable from the first proc) > 3) nnz[1] on the first proc, thus in AO, which produces new mallocs. > > 2. still seems to most probable for me, but before implementing sending the stuff around using MPI, I wanted to ask you > if it is correct that way? If it needs to be done that way, is there some PETSc magic which helps exchanging that array? > > If the answer lies within MatPreallocate* routines, I failed to see :-/ > > Best Thanks, > Florian > > >>> On Jul 10, 2017, at 3:22 AM, Florian Lindner wrote: >>> >>> Hey, >>> >>> one more question about preallocation: >>> >>> I can determine if a column index is diagonal or off-diagonal using that code >>> >>> if (col >= col_range_start and col < col_range_end) >>> d_nnz[relative_row]++; >>> else >>> o_nnz[relative_row]++; >>> >>> >>> My code, however uses index sets from which a ISlocalToGlobalMapping created: >>> >>> // Creates a mapping from permutation and use that for the cols >>> ierr = ISCreateGeneral(PETSC_COMM_WORLD, local_cols, permutation.data(), PETSC_COPY_VALUES, &ISlocal); CHKERRV(ierr); >>> ierr = ISSetPermutation(ISlocal); CHKERRV(ierr); >>> ierr = ISAllGather(ISlocal, &ISglobal); CHKERRV(ierr); // Gather the IS from all processors >>> ierr = ISLocalToGlobalMappingCreateIS(ISglobal, &ISmapping); CHKERRV(ierr); // Make it a mapping >>> >>> // Create an identity mapping and use that for the rows of A. >>> ierr = ISCreateStride(PETSC_COMM_WORLD, local_rows, row_range_start, 1, &ISidentity); CHKERRV(ierr); >>> ierr = ISSetIdentity(ISidentity); CHKERRV(ierr); >>> ierr = ISAllGather(ISidentity, &ISidentityGlobal); CHKERRV(ierr); >>> ierr = ISLocalToGlobalMappingCreateIS(ISidentityGlobal, &ISidentityMapping); CHKERRV(ierr); >>> >>> ierr = MatSetLocalToGlobalMapping(A, ISidentityMapping, ISmapping); CHKERRV(ierr); >>> >>> since SetPreallocation routines define the diagonal / off-diagonal blocks from the petsc ordering, I have to translate >>> the col to a petsc_col. >>> >>> What is the best / fastest way to do that? >>> >>> Is that the way to go? >>> >>> PetscInt mapSize; >>> ISLocalToGlobalMappingGetSize(ISmapping, &mapSize); >>> const PetscInt *mapIndizes; >>> ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); >>> >>> Thanks, >>> Florian >>> >>> >>> >>> Am 07.07.2017 um 17:31 schrieb Florian Lindner: >>>> Hello, >>>> >>>> I'm having some struggle understanding the preallocation for MPIAIJ matrices, especially when a value is in off-diagonal >>>> vs. diagonal block. >>>> >>>> The small example program is at https://pastebin.com/67dXnGm3 >>>> >>>> In general it should be parallel, but right now I just run it in serial. >>>> >>>> According to my understanding of >>>> >>>> http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/Mat/MatMPIAIJSetPreallocation.html >>>> >>>> a entry is in the diagonal submatrix, if its row is in the OwnershipRange and its column is in OwnershipRangeColumn. >>>> That also means that in a serial run, there is only a diagonal submatrix. >>>> >>>> However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when >>>> >>>> Inserting 6 elements in row 2, though I have exactly >>>> >>>> 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal submatrix of row 2) >>>> >>>> Error is: >>>> >>>> [0]PETSC ERROR: Argument out of range >>>> [0]PETSC ERROR: New nonzero at (2,5) caused a malloc >>>> Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn off this check >>>> >>>> >>>> What is wrong with my understanding? >>>> >>>> Thanks, >>>> Florian >>>> >> > From mailinglists at xgm.de Sun Jul 16 21:53:31 2017 From: mailinglists at xgm.de (Florian Lindner) Date: Mon, 17 Jul 2017 10:53:31 +0800 Subject: [petsc-users] Understanding preallocation for MPI In-Reply-To: <527F7048-58C3-466E-8E44-6C17E7B1D584@mcs.anl.gov> References: <3d7ca106-c1da-e9df-a7de-0b75aad2bad3@xgm.de> <527F7048-58C3-466E-8E44-6C17E7B1D584@mcs.anl.gov> Message-ID: <1acf0a6e-9e55-4fae-6f63-26009793eb65@xgm.de> Hi Barry, Am 17.07.2017 um 10:42 schrieb Barry Smith: > The intention with the AO is you map everything to the PETSc ordering and then you just work in the PETSc ordering completely, this way there is no "sending around with MPI preallocation information". That is your matrix assembly and preallocation (as well as vectors) always works in the PETSc numbering. In the PETSc ordering there is no need to send information between processes about row allocations since the information is always on the correct process. The problem I have, is that the information needed to preallocate AO row 1 => PO row 8 is located at rank 0 of my application. So I either need to send the data around to be able to generate the prealloc information of PO row 8 on rank 1 OR send the preallocation data to prealloc PO row 8 on rank 1, albeit generated on rank 0. Is that correct? Best, Florian > > Barry > >> On Jul 16, 2017, at 9:26 PM, Florian Lindner wrote: >> >> Hello, >> >> Am 11.07.2017 um 02:45 schrieb Barry Smith: >>> >>> You might consider using http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatPreallocateInitialize.html and http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatPreallocateSetLocal.html#MatPreallocateSetLocal and friends >>> >>> These take out some of the busywork of setting the preallocation arrays. They are macros in petscmat.h so even if you don't use them you can see the code they use. >> >> Thanks for your input, I took a look at it and learned from it. >> >> I have this preallocation routine which works perfectly for a index set on the columns and non (resp. an identity index >> set) on the columns: >> >> void doPreallocation(Mat &A, ISLocalToGlobalMapping &ISmapping, double nz_ratio, int nz_number) >> { >> PetscInt d_nnz[local_rows], o_nnz[local_rows]; >> >> const PetscInt *mapIndizes; >> ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); >> >> for (int row = row_range_start; row < row_range_end; row++) { >> // PetscInt relative_row = mapIndizes[row- row_range_start]; >> PetscInt relative_row = row - row_range_start; >> d_nnz[relative_row] = 0; >> o_nnz[relative_row] = 0; >> int colStart, colEnd; >> std::tie(colStart, colEnd) = colBorders(row); >> for (int col = 0; col < global_cols; col++) { >> if (col >= colStart and col < colEnd) { >> int petsc_col = mapIndizes[col]; >> if (petsc_col >= col_range_start and petsc_col < col_range_end) { >> d_nnz[relative_row]++; >> } else { >> o_nnz[relative_row]++; >> } >> } >> } >> } >> ierr = ISLocalToGlobalMappingRestoreIndices(ISmapping, &mapIndizes); CHKERRV(ierr); >> ierr = MatMPIAIJSetPreallocation(A, 0, d_nnz, 0, o_nnz); CHKERRV(ierr); // works only on minimum 2 ranks >> } >> >> colStart and colEnd give a defined number of diagonals for the matrix, just for testing. *_range_* are from the PETSc >> routines. >> >> But I'm puzzled how to do it when I have also a (the same) index set for the rows. >> >> Let's say I have 2 procs, a global size of 10 and a mapping [0, 8, 9, 1, 3] on proc 0 and [2, 5, 4, 7, 6] on proc 1. >> >> row_range is [0, 5] on the first proc. >> >> On the first row-iteration I generate data for row 0 (application ordering AO) which is mapped to row 0 (petsc ordering >> PO), I add these nnz to o_/d_nnz[0] >> >> On the second row-iteration I generate data for row 1 (AO) which is mapped to row 8 (PO). As with the columns I expect >> the nnz numbering to be in PO, which means either >> >> 1) nnz[8] (which is not existing), what I would be do in the commented out line. >> 2) nnz[4] on the second proc (which is unreachable from the first proc) >> 3) nnz[1] on the first proc, thus in AO, which produces new mallocs. >> >> 2. still seems to most probable for me, but before implementing sending the stuff around using MPI, I wanted to ask you >> if it is correct that way? If it needs to be done that way, is there some PETSc magic which helps exchanging that array? >> >> If the answer lies within MatPreallocate* routines, I failed to see :-/ >> >> Best Thanks, >> Florian >> >> >>>> On Jul 10, 2017, at 3:22 AM, Florian Lindner wrote: >>>> >>>> Hey, >>>> >>>> one more question about preallocation: >>>> >>>> I can determine if a column index is diagonal or off-diagonal using that code >>>> >>>> if (col >= col_range_start and col < col_range_end) >>>> d_nnz[relative_row]++; >>>> else >>>> o_nnz[relative_row]++; >>>> >>>> >>>> My code, however uses index sets from which a ISlocalToGlobalMapping created: >>>> >>>> // Creates a mapping from permutation and use that for the cols >>>> ierr = ISCreateGeneral(PETSC_COMM_WORLD, local_cols, permutation.data(), PETSC_COPY_VALUES, &ISlocal); CHKERRV(ierr); >>>> ierr = ISSetPermutation(ISlocal); CHKERRV(ierr); >>>> ierr = ISAllGather(ISlocal, &ISglobal); CHKERRV(ierr); // Gather the IS from all processors >>>> ierr = ISLocalToGlobalMappingCreateIS(ISglobal, &ISmapping); CHKERRV(ierr); // Make it a mapping >>>> >>>> // Create an identity mapping and use that for the rows of A. >>>> ierr = ISCreateStride(PETSC_COMM_WORLD, local_rows, row_range_start, 1, &ISidentity); CHKERRV(ierr); >>>> ierr = ISSetIdentity(ISidentity); CHKERRV(ierr); >>>> ierr = ISAllGather(ISidentity, &ISidentityGlobal); CHKERRV(ierr); >>>> ierr = ISLocalToGlobalMappingCreateIS(ISidentityGlobal, &ISidentityMapping); CHKERRV(ierr); >>>> >>>> ierr = MatSetLocalToGlobalMapping(A, ISidentityMapping, ISmapping); CHKERRV(ierr); >>>> >>>> since SetPreallocation routines define the diagonal / off-diagonal blocks from the petsc ordering, I have to translate >>>> the col to a petsc_col. >>>> >>>> What is the best / fastest way to do that? >>>> >>>> Is that the way to go? >>>> >>>> PetscInt mapSize; >>>> ISLocalToGlobalMappingGetSize(ISmapping, &mapSize); >>>> const PetscInt *mapIndizes; >>>> ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); >>>> >>>> Thanks, >>>> Florian >>>> >>>> >>>> >>>> Am 07.07.2017 um 17:31 schrieb Florian Lindner: >>>>> Hello, >>>>> >>>>> I'm having some struggle understanding the preallocation for MPIAIJ matrices, especially when a value is in off-diagonal >>>>> vs. diagonal block. >>>>> >>>>> The small example program is at https://pastebin.com/67dXnGm3 >>>>> >>>>> In general it should be parallel, but right now I just run it in serial. >>>>> >>>>> According to my understanding of >>>>> >>>>> http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/Mat/MatMPIAIJSetPreallocation.html >>>>> >>>>> a entry is in the diagonal submatrix, if its row is in the OwnershipRange and its column is in OwnershipRangeColumn. >>>>> That also means that in a serial run, there is only a diagonal submatrix. >>>>> >>>>> However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when >>>>> >>>>> Inserting 6 elements in row 2, though I have exactly >>>>> >>>>> 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal submatrix of row 2) >>>>> >>>>> Error is: >>>>> >>>>> [0]PETSC ERROR: Argument out of range >>>>> [0]PETSC ERROR: New nonzero at (2,5) caused a malloc >>>>> Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn off this check >>>>> >>>>> >>>>> What is wrong with my understanding? >>>>> >>>>> Thanks, >>>>> Florian >>>>> >>> >> > From bsmith at mcs.anl.gov Sun Jul 16 22:34:57 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 16 Jul 2017 22:34:57 -0500 Subject: [petsc-users] Understanding preallocation for MPI In-Reply-To: <1acf0a6e-9e55-4fae-6f63-26009793eb65@xgm.de> References: <3d7ca106-c1da-e9df-a7de-0b75aad2bad3@xgm.de> <527F7048-58C3-466E-8E44-6C17E7B1D584@mcs.anl.gov> <1acf0a6e-9e55-4fae-6f63-26009793eb65@xgm.de> Message-ID: > On Jul 16, 2017, at 9:53 PM, Florian Lindner wrote: > > Hi Barry, > > Am 17.07.2017 um 10:42 schrieb Barry Smith: >> The intention with the AO is you map everything to the PETSc ordering and then you just work in the PETSc ordering completely, this way there is no "sending around with MPI preallocation information". That is your matrix assembly and preallocation (as well as vectors) always works in the PETSc numbering. In the PETSc ordering there is no need to send information between processes about row allocations since the information is always on the correct process. > > The problem I have, is that the information needed to preallocate AO row 1 => PO row 8 is located at rank 0 of my > application. > > So I either need to send the data around to be able to generate the prealloc information of PO row 8 on rank 1 OR send > the preallocation data to prealloc PO row 8 on rank 1, albeit generated on rank 0. > > Is that correct? Yes, you are suppose to move your data around so that the information for the first rows is on the first process, the information for next rows is on the second process etc. You need to do this for efficiency anyways; this is often the most tedious part of the code to write which is why many users use DMPlex or libMesh or Deal.ii or Firedrake or some other mesh/finite element package since they manage that process and then use PETSc to solver the systems. Barry > > Best, > Florian > > >> >> Barry >> >>> On Jul 16, 2017, at 9:26 PM, Florian Lindner wrote: >>> >>> Hello, >>> >>> Am 11.07.2017 um 02:45 schrieb Barry Smith: >>>> >>>> You might consider using http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatPreallocateInitialize.html and http://www.mcs.anl.gov/petsc/petsc-current/docs/manualpages/Mat/MatPreallocateSetLocal.html#MatPreallocateSetLocal and friends >>>> >>>> These take out some of the busywork of setting the preallocation arrays. They are macros in petscmat.h so even if you don't use them you can see the code they use. >>> >>> Thanks for your input, I took a look at it and learned from it. >>> >>> I have this preallocation routine which works perfectly for a index set on the columns and non (resp. an identity index >>> set) on the columns: >>> >>> void doPreallocation(Mat &A, ISLocalToGlobalMapping &ISmapping, double nz_ratio, int nz_number) >>> { >>> PetscInt d_nnz[local_rows], o_nnz[local_rows]; >>> >>> const PetscInt *mapIndizes; >>> ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); >>> >>> for (int row = row_range_start; row < row_range_end; row++) { >>> // PetscInt relative_row = mapIndizes[row- row_range_start]; >>> PetscInt relative_row = row - row_range_start; >>> d_nnz[relative_row] = 0; >>> o_nnz[relative_row] = 0; >>> int colStart, colEnd; >>> std::tie(colStart, colEnd) = colBorders(row); >>> for (int col = 0; col < global_cols; col++) { >>> if (col >= colStart and col < colEnd) { >>> int petsc_col = mapIndizes[col]; >>> if (petsc_col >= col_range_start and petsc_col < col_range_end) { >>> d_nnz[relative_row]++; >>> } else { >>> o_nnz[relative_row]++; >>> } >>> } >>> } >>> } >>> ierr = ISLocalToGlobalMappingRestoreIndices(ISmapping, &mapIndizes); CHKERRV(ierr); >>> ierr = MatMPIAIJSetPreallocation(A, 0, d_nnz, 0, o_nnz); CHKERRV(ierr); // works only on minimum 2 ranks >>> } >>> >>> colStart and colEnd give a defined number of diagonals for the matrix, just for testing. *_range_* are from the PETSc >>> routines. >>> >>> But I'm puzzled how to do it when I have also a (the same) index set for the rows. >>> >>> Let's say I have 2 procs, a global size of 10 and a mapping [0, 8, 9, 1, 3] on proc 0 and [2, 5, 4, 7, 6] on proc 1. >>> >>> row_range is [0, 5] on the first proc. >>> >>> On the first row-iteration I generate data for row 0 (application ordering AO) which is mapped to row 0 (petsc ordering >>> PO), I add these nnz to o_/d_nnz[0] >>> >>> On the second row-iteration I generate data for row 1 (AO) which is mapped to row 8 (PO). As with the columns I expect >>> the nnz numbering to be in PO, which means either >>> >>> 1) nnz[8] (which is not existing), what I would be do in the commented out line. >>> 2) nnz[4] on the second proc (which is unreachable from the first proc) >>> 3) nnz[1] on the first proc, thus in AO, which produces new mallocs. >>> >>> 2. still seems to most probable for me, but before implementing sending the stuff around using MPI, I wanted to ask you >>> if it is correct that way? If it needs to be done that way, is there some PETSc magic which helps exchanging that array? >>> >>> If the answer lies within MatPreallocate* routines, I failed to see :-/ >>> >>> Best Thanks, >>> Florian >>> >>> >>>>> On Jul 10, 2017, at 3:22 AM, Florian Lindner wrote: >>>>> >>>>> Hey, >>>>> >>>>> one more question about preallocation: >>>>> >>>>> I can determine if a column index is diagonal or off-diagonal using that code >>>>> >>>>> if (col >= col_range_start and col < col_range_end) >>>>> d_nnz[relative_row]++; >>>>> else >>>>> o_nnz[relative_row]++; >>>>> >>>>> >>>>> My code, however uses index sets from which a ISlocalToGlobalMapping created: >>>>> >>>>> // Creates a mapping from permutation and use that for the cols >>>>> ierr = ISCreateGeneral(PETSC_COMM_WORLD, local_cols, permutation.data(), PETSC_COPY_VALUES, &ISlocal); CHKERRV(ierr); >>>>> ierr = ISSetPermutation(ISlocal); CHKERRV(ierr); >>>>> ierr = ISAllGather(ISlocal, &ISglobal); CHKERRV(ierr); // Gather the IS from all processors >>>>> ierr = ISLocalToGlobalMappingCreateIS(ISglobal, &ISmapping); CHKERRV(ierr); // Make it a mapping >>>>> >>>>> // Create an identity mapping and use that for the rows of A. >>>>> ierr = ISCreateStride(PETSC_COMM_WORLD, local_rows, row_range_start, 1, &ISidentity); CHKERRV(ierr); >>>>> ierr = ISSetIdentity(ISidentity); CHKERRV(ierr); >>>>> ierr = ISAllGather(ISidentity, &ISidentityGlobal); CHKERRV(ierr); >>>>> ierr = ISLocalToGlobalMappingCreateIS(ISidentityGlobal, &ISidentityMapping); CHKERRV(ierr); >>>>> >>>>> ierr = MatSetLocalToGlobalMapping(A, ISidentityMapping, ISmapping); CHKERRV(ierr); >>>>> >>>>> since SetPreallocation routines define the diagonal / off-diagonal blocks from the petsc ordering, I have to translate >>>>> the col to a petsc_col. >>>>> >>>>> What is the best / fastest way to do that? >>>>> >>>>> Is that the way to go? >>>>> >>>>> PetscInt mapSize; >>>>> ISLocalToGlobalMappingGetSize(ISmapping, &mapSize); >>>>> const PetscInt *mapIndizes; >>>>> ISLocalToGlobalMappingGetIndices(ISmapping, &mapIndizes); >>>>> >>>>> Thanks, >>>>> Florian >>>>> >>>>> >>>>> >>>>> Am 07.07.2017 um 17:31 schrieb Florian Lindner: >>>>>> Hello, >>>>>> >>>>>> I'm having some struggle understanding the preallocation for MPIAIJ matrices, especially when a value is in off-diagonal >>>>>> vs. diagonal block. >>>>>> >>>>>> The small example program is at https://pastebin.com/67dXnGm3 >>>>>> >>>>>> In general it should be parallel, but right now I just run it in serial. >>>>>> >>>>>> According to my understanding of >>>>>> >>>>>> http://www.mcs.anl.gov/petsc/petsc-3.7/docs/manualpages/Mat/MatMPIAIJSetPreallocation.html >>>>>> >>>>>> a entry is in the diagonal submatrix, if its row is in the OwnershipRange and its column is in OwnershipRangeColumn. >>>>>> That also means that in a serial run, there is only a diagonal submatrix. >>>>>> >>>>>> However, having MAT_NEW_NONZERO_ALLOCATION_ERR set, I get an error when >>>>>> >>>>>> Inserting 6 elements in row 2, though I have exactly >>>>>> >>>>>> 2 o_nnz = 0, d_nnz = 6 (means 6 elements allocated in the diagonal submatrix of row 2) >>>>>> >>>>>> Error is: >>>>>> >>>>>> [0]PETSC ERROR: Argument out of range >>>>>> [0]PETSC ERROR: New nonzero at (2,5) caused a malloc >>>>>> Use MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn off this check >>>>>> >>>>>> >>>>>> What is wrong with my understanding? >>>>>> >>>>>> Thanks, >>>>>> Florian >>>>>> >>>> >>> >> From lirui319 at hnu.edu.cn Mon Jul 17 09:16:25 2017 From: lirui319 at hnu.edu.cn (=?GBK?B?wO7I8A==?=) Date: Mon, 17 Jul 2017 22:16:25 +0800 (GMT+08:00) Subject: [petsc-users] Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE Message-ID: <3d946c.de37.15d50e84493.Coremail.lirui319@hnu.edu.cn> Dear professor or engineer: I recently attempt to solve the system of equation that consist of two sub equations,which are respetivly spatially and timely dependant.The structure of equations are likely : F_1(x,y)=0;F_2(w(t),x)=0.and y can be explicitly obtained in each time step.We need to pay attention to the first equation is a linear equation and the second a nonlinear equation dependent on time.Getting W(t0) by sequentially obtain y and x. When I solve the equation F1 in first time step,the result was convergent,but in the second step was not.The answer reveals that: >>>In the first time step: .... 126 KSP Residual norm 6.505554772167e-03 127 KSP Residual norm 2.563866095029e-03 128 KSP Residual norm 5.365504095451e-04 129 KSP Residual norm 9.699344087450e-05 130 KSP Residual norm 2.793539286585e-05 131 KSP Residual norm 8.413249813721e-06 132 KSP Residual norm 2.488394296066e-06 133 KSP Residual norm 1.055822777756e-06 134 KSP Residual norm 7.820629842889e-07 Nonlinear solve converged due to CONVERGED_ITS >>>In the second time step : .... 294 KSP Residual norm 2.632117164436e+03 295 KSP Residual norm 2.627315190869e+03 296 KSP Residual norm 2.626944159914e+03 297 KSP Residual norm 2.625073489387e+03 298 KSP Residual norm 2.624035038684e+03 299 KSP Residual norm 2.623956156495e+03 300 KSP Residual norm 2.623696336837e+03 Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE The following code is typing my makefile. -linear_ksp_monitor -linear_snes_converged_reason -linear_snes_atol 1.e-4 -linear_snes_rtol 1.e-60 -linear_ksp_type gmres \ -linear_ksp_max_it 300 -linear_ksp_atol 1.e-6 -linear_ksp_gmres_restart 90 -linear_ksp_rtol 1.e-60 \ -linear_ksp_pc_side right -linear_pc_type asm -linear_pc_asm_type restrict -linear_pc_asm_overlap 1 \ -linear_sub_ksp_type preonly -linear_sub_pc_type lu \ Is there anything wrong,Pc_type or Krylov method?Can you give me some detailed suggestions or other ways to solve my obsession?Thank for your heartful help! From mfadams at lbl.gov Mon Jul 17 09:22:12 2017 From: mfadams at lbl.gov (Mark Adams) Date: Mon, 17 Jul 2017 10:22:12 -0400 Subject: [petsc-users] Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE In-Reply-To: <3d946c.de37.15d50e84493.Coremail.lirui319@hnu.edu.cn> References: <3d946c.de37.15d50e84493.Coremail.lirui319@hnu.edu.cn> Message-ID: This makes no sense: -linear_snes_rtol 1.e-60 This is the relative tolerance and so 1.e-14 with double precision about as low as you want to go. Right? I'm not sure why this converges at all. Anyway, It looks like your problem get hard after the first time step. Run with one processor and 'lu' instead of 'asm' for the pc_type. This is a direct solver. Then I would look at your solution and make sure that it looks OK. Often poor iterative solver performance is correlated with a simulations that is bad. And what kind of equation and discretization is this? On Mon, Jul 17, 2017 at 10:16 AM, ?? wrote: > > Dear professor or engineer: > I recently attempt to solve the system of equation that consist of two > sub equations,which are respetivly spatially and timely dependant.The > structure of equations are likely : F_1(x,y)=0;F_2(w(t),x)=0.and y can be > explicitly obtained in each time step.We need to pay attention to the first > equation is a linear equation and the second a nonlinear equation > dependent on time.Getting W(t0) by sequentially obtain y and x. > When I solve the equation F1 in first time step,the result was > convergent,but in the second step was not.The answer reveals that: > >>>In the first time step: > .... > 126 KSP Residual norm 6.505554772167e-03 > 127 KSP Residual norm 2.563866095029e-03 > 128 KSP Residual norm 5.365504095451e-04 > 129 KSP Residual norm 9.699344087450e-05 > 130 KSP Residual norm 2.793539286585e-05 > 131 KSP Residual norm 8.413249813721e-06 > 132 KSP Residual norm 2.488394296066e-06 > 133 KSP Residual norm 1.055822777756e-06 > 134 KSP Residual norm 7.820629842889e-07 > Nonlinear solve converged due to CONVERGED_ITS > > >>>In the second time step : > .... > 294 KSP Residual norm 2.632117164436e+03 > 295 KSP Residual norm 2.627315190869e+03 > 296 KSP Residual norm 2.626944159914e+03 > 297 KSP Residual norm 2.625073489387e+03 > 298 KSP Residual norm 2.624035038684e+03 > 299 KSP Residual norm 2.623956156495e+03 > 300 KSP Residual norm 2.623696336837e+03 > Nonlinear solve did not converge due to DIVERGED_LINEAR_SOLVE > > The following code is typing my makefile. > -linear_ksp_monitor -linear_snes_converged_reason -linear_snes_atol 1.e-4 > -linear_snes_rtol 1.e-60 -linear_ksp_type gmres \ > -linear_ksp_max_it 300 -linear_ksp_atol 1.e-6 -linear_ksp_gmres_restart 90 > -linear_ksp_rtol 1.e-60 \ > -linear_ksp_pc_side right -linear_pc_type asm -linear_pc_asm_type restrict > -linear_pc_asm_overlap 1 \ > -linear_sub_ksp_type preonly -linear_sub_pc_type lu \ > > Is there anything wrong,Pc_type or Krylov method?Can you give me some > detailed suggestions or other ways to solve my obsession?Thank for your > heartful help! > -------------- next part -------------- An HTML attachment was scrubbed... URL: From j.pogacnik at auckland.ac.nz Mon Jul 17 15:38:19 2017 From: j.pogacnik at auckland.ac.nz (Justin Pogacnik) Date: Mon, 17 Jul 2017 20:38:19 +0000 Subject: [petsc-users] [FORGED] Re: NULL section fortran In-Reply-To: References: <1499889127627.57606@auckland.ac.nz>, Message-ID: <1500323901867.83412@auckland.ac.nz> Thanks for the response Barry. Matt, is this something that will be pushed out soon(ish)? Thanks guys! Justin ________________________________________ From: Barry Smith Sent: Thursday, July 13, 2017 7:59 AM To: Justin Pogacnik Cc: petsc-users at mcs.anl.gov Subject: [FORGED] Re: [petsc-users] NULL section fortran Matt needs to add something like PetscSection, parameter :: PETSC_NULL_SECTION = tPetscSection(-1) PetscSectionSym, parameter :: PETSC_NULL_SECTIONSYM = tPetscSectionSym(-1) to src/vec/f90-mod/petscis.h in the master branch. Barry > On Jul 12, 2017, at 2:52 PM, Justin Pogacnik wrote: > > Hello, > > I'm assembling a global finite element stiffness matrix and using the DMPlexMatSetClosure command in fortran. Long ago, in the past, I've used to set the section input parameters to PETSC_NULL_OBJECT. That now returns an error -- no implicit type -- during compilation. Looking at the defined null objects for fortran I don't see a section option. What should I use to invoke the default sections? > > Hope this makes sense. Thanks! > > Justin From skavou1 at lsu.edu Wed Jul 19 10:10:32 2017 From: skavou1 at lsu.edu (Sepideh Kavousi) Date: Wed, 19 Jul 2017 15:10:32 +0000 Subject: [petsc-users] error in DMDACreate3d Message-ID: Hi, I am writing a petsc code where I create a 3d da object using DMDACreate3d, I want to have 2 processors in x , 1 processor in y and 2 processors in z direction. for this I write: ierr= DMDACreate3d(PETSC_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_BOX, 60,60,60,2,1,2,2,1,llx,lly,llz,&da2) ;CHKERRQ(ierr); and llx and lly and llz are as : llx[2]={30,30},lly[1]={60},llz[2]={30,30} it works fine when I run with my personal workstation. But when I want to run it on hpc it gives an error. and by running with valgrind it gives the following error. I do not understand why it says: Too many processors in X direction: 2 1. Can some one please help me about it? Thanks, Sepideh ==102997== Memcheck, a memory error detector ==102997== Copyright (C) 2002-2012, and GNU GPL'd, by Julian Seward et al. ==102997== Using Valgrind-3.8.1 and LibVEX; rerun with -h for copyright info ==102997== Command: mpiexec -n 4 ./try3-jacob-3.out -ts_monitor -snes_monitor -snes_mf -log_view -ts_max_snes_failures -1 -ts_type bdf -snes_type newtontr -pc_type asm -ksp_gmres_restart 300 -sub_ksp_type preonly -sub_pc_type lu -pc_asm_overlap 4 -ts_adapt_monitor -snes_linesearch_type bt -ksp_type gmres -snes_atol 1.0e-20 -snes_monitor -ts_view -ts_adapt_monitor ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAC833: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40446C: orterun (orterun.c:494) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61528f8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x742F2E0034006E2C: ??? ==102997== by 0x6F63616A2D337971: ??? ==102997== by 0x74756F2E332D61: ??? ==102997== by 0x696E6F6D5F73742C: ??? ==102997== by 0x656E732D00726F73: ??? ==102997== by 0x6F74696E6F6D5F72: ??? ==102997== by 0x5F73656E732D0071: ??? ==102997== by 0x5F676F6C2D00666C: ??? ==102997== by 0x73742D0077656975: ??? ==102997== by 0x656E735F78616D5E: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAC886: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40446C: orterun (orterun.c:494) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61528f8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x742F2E0034006E2C: ??? ==102997== by 0x6F63616A2D337971: ??? ==102997== by 0x74756F2E332D61: ??? ==102997== by 0x696E6F6D5F73742C: ??? ==102997== by 0x656E732D00726F73: ??? ==102997== by 0x6F74696E6F6D5F72: ??? ==102997== by 0x5F73656E732D0071: ??? ==102997== by 0x5F676F6C2D00666C: ??? ==102997== by 0x73742D0077656975: ??? ==102997== by 0x656E735F78616D5E: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044AA: orterun (orterun.c:498) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044AA: orterun (orterun.c:498) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044AA: orterun (orterun.c:498) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044AA: orterun (orterun.c:498) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044AA: orterun (orterun.c:498) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044AA: orterun (orterun.c:498) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044AA: orterun (orterun.c:498) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044AA: orterun (orterun.c:498) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044AA: orterun (orterun.c:498) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044AA: orterun (orterun.c:498) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044B9: orterun (orterun.c:499) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044B9: orterun (orterun.c:499) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044B9: orterun (orterun.c:499) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044B9: orterun (orterun.c:499) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044B9: orterun (orterun.c:499) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044B9: orterun (orterun.c:499) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044B9: orterun (orterun.c:499) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044B9: orterun (orterun.c:499) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAD821: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044E1: orterun (orterun.c:500) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x615ce50 is 0 bytes inside a block of size 3 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F63616A2D337971: ??? ==102997== by 0x74756F2E332D61: ??? ==102997== by 0x696E6F6D5F73742C: ??? ==102997== by 0x656E732D00726F73: ??? ==102997== by 0x6F74696E6F6D5F72: ??? ==102997== by 0x5F73656E732D0071: ??? ==102997== by 0x5F676F6C2D00666C: ??? ==102997== by 0x73742D0077656975: ??? ==102997== by 0x656E735F78616D5E: ??? ==102997== by 0x72756C6961665F72: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAD9D5: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044E1: orterun (orterun.c:500) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x615ce50 is 0 bytes inside a block of size 3 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F63616A2D337971: ??? ==102997== by 0x74756F2E332D61: ??? ==102997== by 0x696E6F6D5F73742C: ??? ==102997== by 0x656E732D00726F73: ??? ==102997== by 0x6F74696E6F6D5F72: ??? ==102997== by 0x5F73656E732D0071: ??? ==102997== by 0x5F676F6C2D00666C: ??? ==102997== by 0x73742D0077656975: ??? ==102997== by 0x656E735F78616D5E: ??? ==102997== by 0x72756C6961665F72: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CABAF8: opal_argv_append_nosize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CABB75: opal_argv_append (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAD38B: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044E1: orterun (orterun.c:500) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x615cf00 is 0 bytes inside a block of size 2 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x332D626F63616A2C: ??? ==102997== by 0x73742D0074756F2D: ??? ==102997== by 0x726F74696E6F6D5E: ??? ==102997== by 0x6D5F73656E732CFF: ??? ==102997== by 0x2D00726F74696E6E: ??? ==102997== by 0x666D5F73656E72: ??? ==102997== by 0x6569765F676F6C2C: ??? ==102997== by 0x616D5F73742D0076: ??? ==102997== by 0x665F73656E735F77: ??? ==102997== by 0x736572756C6960: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EF46: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== Address 0x615cfd0 is 16 bytes inside a block of size 19 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E332D626F6360: ??? ==102997== by 0x6D5F73742D007474: ??? ==102997== by 0x2D00726F74696E6E: ??? ==102997== by 0x6E6F6D5F73656E72: ??? ==102997== by 0x6E732D00726F7468: ??? ==102997== by 0x6C2D00666D5F7364: ??? ==102997== by 0x776569765F676E: ??? ==102997== by 0x5F78616D5F73742C: ??? ==102997== by 0x6961665F73656E72: ??? ==102997== by 0x312D00736572756B: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CABAF8: opal_argv_append_nosize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CABB75: opal_argv_append (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAD600: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4044E1: orterun (orterun.c:500) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x615d098 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x656E732D00726F73: ??? ==102997== by 0x6F74696E6F6D5F72: ??? ==102997== by 0x5F73656E732D0071: ??? ==102997== by 0x5F676F6C2D00666C: ??? ==102997== by 0x73742D0077656975: ??? ==102997== by 0x656E735F78616D5E: ??? ==102997== by 0x72756C6961665F72: ??? ==102997== by 0x742D00312D007364: ??? ==102997== by 0x6200657079745F72: ??? ==102997== by 0x73656E732D006663: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB698C: opal_output_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9023: opal_output_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84BBD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6161a80 is 16 bytes inside a block of size 18 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CB8E9E: opal_output_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84BBD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6164d48 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAACDD: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61650b0 is 16 bytes inside a block of size 23 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA6F6A3: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA756C4: _IO_str_init_static_internal (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F703: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA7455B: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA7456F: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA74578: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA74582: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA74670: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA745E5: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA48160: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0A02A: mempcpy (mc_replace_strmem.c:1268) ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0A033: mempcpy (mc_replace_strmem.c:128) ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0A048: mempcpy (mc_replace_strmem.c:1268) ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0A095: mempcpy (mc_replace_strmem.c:1268) ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A0A0A8: mempcpy (mc_replace_strmem.c:1268) ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A0A0AC: mempcpy (mc_replace_strmem.c:1268) ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0A0BB: mempcpy (mc_replace_strmem.c:1268) ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A0A0BB: mempcpy (mc_replace_strmem.c:1268) ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x3C8BA6F71E: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAACDD: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61656f0 is 16 bytes inside a block of size 21 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA6F6A3: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x3C8BA6F71E: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAACDD: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6165ce8 is 24 bytes inside a block of size 27 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA6F6A3: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x3C8BA6F71E: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08B6A: memcpy (mc_replace_strmem.c:119) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08B8C: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08C18: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08C3E: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08C5B: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08C6C: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A08C80: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A08C8C: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08C98: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08CB2: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A08CB8: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A08CBF: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08CCA: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F2E2F31756F7660: ??? ==102997== by 0x6D2F69706D6E656F: ??? ==102997== by 0x6D617261702D6162: ??? ==102997== by 0x666E6F632E72: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB510C: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB511A: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A06BAE: realloc (vg_replace_malloc.c:662) ==102997== by 0x4CB5137: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB5164: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB517C: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E3B5: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E410: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== ==102997== More than 100 errors detected. Subsequent errors ==102997== will still be recorded, but in less detail than before. ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E41D: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E4EC: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E502: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB518B: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAB8E9: save_value (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB52E6: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08D03: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08D09: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A08D21: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A08D28: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08D2A: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08D13: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08D30: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08D76: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CABAF8: opal_argv_append_nosize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CABB75: opal_argv_append (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CABD1F: opal_argv_split (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB5630: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617be00 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x3C8BA74667: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAE55: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617bb58 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4C84F41: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617c038 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA55D0: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA55D0: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA55DD: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA55DD: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85027: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617c238 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA7458C: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85027: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF201F: opal_shmem_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8503E: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617c418 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA560D: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF201F: opal_shmem_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8503E: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF8F8: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617d198 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA7356: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA7356: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA7370: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA7370: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA737C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA737C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA73A8: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF9B7: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617d9d8 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA844D: mca_base_param_lookup_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBCC96: opal_util_register_stackhandlers (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CB2: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617bf28 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA82F4: mca_base_param_lookup_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBCC96: opal_util_register_stackhandlers (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CB2: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617dd18 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5557: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBD0B0: opal_util_init_sys_limits (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CCB: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617de60 is 16 bytes inside a block of size 19 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA621A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617e070 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617e0c0 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA62C7: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA62C7: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA62E2: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA62E2: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA630A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA630A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA6317: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA6317: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA621A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617e238 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617e280 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA630A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA6317: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA6347: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA6236: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AB67: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617f550 is 16 bytes inside a block of size 17 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8AB67: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40458C: orterun (orterun.c:535) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x617f5a0 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C42E29: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6180ff8 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C42E29: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6181058 is 24 bytes inside a block of size 31 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CAACE8: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C42E29: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C42E7C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6181408 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C42EBD: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61815f0 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C42EBD: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C42F08: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61817e8 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C42F2E: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61819d8 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C4315F: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6184ff8 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C431A0: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61851f8 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA560D: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C431A0: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6185258 is 24 bytes inside a block of size 31 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CA5562: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C431A0: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C431EB: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61853e8 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43245: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6185818 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43298: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6185c30 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43298: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C432D9: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6185e18 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43339: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6186028 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C433E1: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6186508 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43432: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6186728 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43511: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6186de8 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43511: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA7356: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43530: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C435AA: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61874a8 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C435EB: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6187688 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43643: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6187878 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43689: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6187a68 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43689: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C437A6: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61882d8 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C437F2: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61884d8 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA8E12: param_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAAF43: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C437F2: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61885f0 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA8CCF: param_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CAAF43: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C437F2: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6188640 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43860: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61889b0 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43860: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C438EE: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6188e18 is 8 bytes inside a block of size 10 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C438EE: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA739C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43910: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA739C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C4392B: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43A3C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6189c78 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43A3C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43A6C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6189e48 is 8 bytes inside a block of size 10 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43A6C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43A95: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x618e478 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43AD1: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x618e648 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43B0D: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x618e818 is 8 bytes inside a block of size 10 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43B0D: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43D03: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x618edf8 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C43D4B: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404BB9: orterun (orterun.c:632) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x618efd8 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAD9D5: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4092E9: create_app (orterun.c:1908) ==102997== by 0x408ACD: parse_locals (orterun.c:1681) ==102997== by 0x404D1E: orterun (orterun.c:658) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x619c0f0 is 0 bytes inside a block of size 3 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4826: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61ae808 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4871: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA48C5: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af098 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA48C5: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA48FA: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af200 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4933: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af250 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4982: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af250 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6C67: opal_output_reopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C03: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af360 is 16 bytes inside a block of size 18 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA4BF7: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C8EB45: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F942: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af548 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8B6C2: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F92A: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C8FAA6: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af598 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F942: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C8FBE5: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af598 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F942: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C9172F: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af5e0 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C9179A: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af5e0 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C8B67F: lt__strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af638 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9175B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4C8B68F: lt__strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0937A: _intel_fast_memcpy (mc_replace_strmem.c:119) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0939C: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09513: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09519: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A09531: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A09538: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0953A: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09540: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A0955C: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A09563: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09566: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09586: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C92C11: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af5e0 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 4 ==102997== at 0x40E2D8: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92DD2: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af5e4 is 4 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 4 ==102997== at 0x40E2E4: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92DD2: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af5e4 is 4 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D22: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D22: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFAB7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61af968 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA43F0: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3E4A: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61b09d8 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8E79B: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61b0cc8 is 56 bytes inside a block of size 59 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA8AEE2: argz_create_sep (in /lib64/libc-2.12.so) ==102997== by 0x4C8E710: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E31C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8E809: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61b0cc8 is 56 bytes inside a block of size 59 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA8AEE2: argz_create_sep (in /lib64/libc-2.12.so) ==102997== by 0x4C8E710: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C919D5: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61b0d48 is 56 bytes inside a block of size 60 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E7D1: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C919D5: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4C919D6: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91A66: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61b0d48 is 56 bytes inside a block of size 60 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E7D1: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91A66: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E31C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61b0d48 is 56 bytes inside a block of size 60 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E7D1: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E32C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E33C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E345: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E35C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E373: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E38C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91BAA: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91BAA: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EC15: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91BB8: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EC37: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91BB8: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91BB8: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4C91BB9: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91E19: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61b8e48 is 72 bytes inside a block of size 73 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91B6C: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E5B8: __intel_sse2_strend (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91C66: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61bbcd0 is 1,088 bytes inside a block of size 1,091 alloc'd ==102997== at 0x4A06C20: realloc (vg_replace_malloc.c:662) ==102997== by 0x3C8BA8B16F: argz_insert (in /lib64/libc-2.12.so) ==102997== by 0x4C91C9D: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E5B8: __intel_sse2_strend (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C91D8D: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6201eb8 is 6,312 bytes inside a block of size 6,314 alloc'd ==102997== at 0x4A06C20: realloc (vg_replace_malloc.c:662) ==102997== by 0x3C8BA8B16F: argz_insert (in /lib64/libc-2.12.so) ==102997== by 0x4C91C9D: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E5B8: __intel_sse2_strend (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8E8A7: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61b0cc8 is 56 bytes inside a block of size 59 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA8AEE2: argz_create_sep (in /lib64/libc-2.12.so) ==102997== by 0x4C8E710: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E578: __intel_sse2_strchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA1DC4: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61b0bc8 is 88 bytes inside a block of size 93 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8E6A2: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61b0bc8 is 88 bytes inside a block of size 93 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA17BE: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA189F: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6202798 is 72 bytes inside a block of size 76 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E5DA: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E601: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E677: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA621A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x620e438 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x620e488 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA62C7: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E6C8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6207c18 is 72 bytes inside a block of size 79 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E774: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E8C1: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E8C9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E8D8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA1988: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CA198A: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 4 ==102997== at 0x40E3C0: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6207c1c is 76 bytes inside a block of size 79 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 4 ==102997== at 0x40E3C8: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6207c1c is 76 bytes inside a block of size 79 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E449: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA19F5: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6207c18 is 72 bytes inside a block of size 79 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E477: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA1A4C: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6207c18 is 72 bytes inside a block of size 79 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E8E4: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E8E9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8EB61: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C693: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x62116a0 is 80 bytes inside a block of size 82 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C660: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8C833: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6211740 is 80 bytes inside a block of size 82 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C693: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8C973: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6211740 is 80 bytes inside a block of size 82 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C693: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8D5C6: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6212438 is 56 bytes inside a block of size 59 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F50B: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8D633: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6212340 is 16 bytes inside a block of size 23 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F5BD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8B69B: lt__strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D702: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6212570 is 80 bytes inside a block of size 82 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D645: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA27FB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92BAA: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92C2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6211820 is 16 bytes inside a block of size 20 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C9CA: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4C92C41: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E2FA: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92DD2: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6211820 is 16 bytes inside a block of size 20 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C9CA: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D22: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EA59: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EA98: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EAB8: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EB8D: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EB92: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EB96: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E30A: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E33C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E345: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E35C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E373: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E38C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6213710 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6213768 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FB7: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FB7: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FD2: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FD2: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5007: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5007: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5037: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6214b60 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4F59: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6214bc0 is 16 bytes inside a block of size 20 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FFA: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FFA: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5007: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5037: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6214c38 is 40 bytes inside a block of size 46 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CA4F64: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF41D: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6214de0 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF449: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x62150e0 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF475: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x62153e0 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEBAC2: opal_memory_linux_hook_pull (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF5E7: opal_memory_linux_ptmalloc2_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF4D6: linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6215710 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEBAC2: opal_memory_linux_hook_pull (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF5E7: opal_memory_linux_ptmalloc2_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CEF4D6: linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6215768 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE62C9: opal_memchecker_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A61: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6315bd8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA55DD: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CE62C9: opal_memchecker_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84A61: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E774: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E8C9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E8D8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E8E4: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E8E9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDE5F: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6317f38 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E449: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6203110 is 80 bytes inside a block of size 81 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E477: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA19F5: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6203110 is 80 bytes inside a block of size 81 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA7455B: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA7456F: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA74578: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA74582: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA74670: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA745E5: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA440F3: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA7455B: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA7456F: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA74578: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA74582: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x3C8BA74667: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA74670: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA745E5: _IO_default_xsputn (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x3C8BA445F0: vfprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E924: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8EEA1: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E93F: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8EEA1: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8EEDB: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4C8EF1B: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4C8EF24: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4C8EF2E: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0937A: _intel_fast_memcpy (mc_replace_strmem.c:119) ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0939C: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09513: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09595: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A095FC: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A095FF: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09601: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4C8F4EB: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E924: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8EFBD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E93F: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8EFBD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C8EFF7: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4C8F031: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4C8F03A: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4C8F044: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0937A: _intel_fast_memcpy (mc_replace_strmem.c:119) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0939C: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09513: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09519: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A09531: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A09538: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A0953A: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09523: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09540: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A0955C: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A09563: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09566: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A09586: _intel_fast_memcpy (mc_replace_strmem.c:893) ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4C8F544: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C92C11: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x631f078 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C9CA: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6F58B51: auto_detect_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_auto_detect.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6320d18 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6F58B51: auto_detect_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_auto_detect.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6320d68 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FFA: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x6F58B51: auto_detect_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_auto_detect.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6320fd0 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6321020 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C05: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C05: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C20: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C20: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C48: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C48: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DBA9: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6321200 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715DBA9: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6321258 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9F0E2: opal_event_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84AF7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6321908 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715B212: mmap_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x632f120 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715B280: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x632f380 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715B280: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x632f3d8 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715B2A9: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x632f700 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x632f990 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5BA2: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x632f9f0 is 16 bytes inside a block of size 22 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C85: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x632fa68 is 40 bytes inside a block of size 46 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CA5BAE: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C85: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x735DFDC: posix_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_posix.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x632fd00 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x735DFDC: posix_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_posix.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x632fd58 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7560CAC: sysv_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_sysv.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x632ffb0 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7560CAC: sysv_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_sysv.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6330008 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85CB1: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6330308 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85D36: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63304e8 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EEB2: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85D36: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85D36: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85D98: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63306c8 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85E6D: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6330d28 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85ED7: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6330f30 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85ED7: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85F2C: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6331158 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C85FBF: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6331358 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C475E9: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63315c8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C475E9: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C476C2: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6331998 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C476C2: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C476FD: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47739: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6331bb8 is 8 bytes inside a block of size 10 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47739: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C4777C: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6331d98 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 4 ==102997== at 0x40E424: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x620466c is 76 bytes inside a block of size 77 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 4 ==102997== at 0x40E42C: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x620466c is 76 bytes inside a block of size 77 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C8D617: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x634c6d8 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8F5BD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA6347: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x635bf28 is 24 bytes inside a block of size 30 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CA6274: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637cbb0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637cc08 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FB7: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969BC3: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637cdf0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969BC3: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637ce48 is 8 bytes inside a block of size 10 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969C04: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637d040 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969C04: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637d098 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969C45: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637d290 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969C45: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637d2e8 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969C86: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637d4f0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969CC7: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637d740 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969D12: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637d9a0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969D12: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637d9f8 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969D3E: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637dc60 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969D3E: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637dcb0 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969D3E: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969D60: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637de90 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969D60: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637dee8 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637e120 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637e170 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C05: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D74DB2: plm_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637e640 is 0 bytes inside a block of size 3 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D74DB2: plm_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C74769: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637ea40 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C747C8: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637ea40 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x6F76616B732F6B71: ??? ==102997== by 0x74706164612F3174: ??? ==102997== by 0x796C754A2F657668: ??? ==102997== by 0x6D756E2D656E6F2E: ??? ==102997== by 0x366E6F6974616562: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB65CA: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== Address 0x637ec68 is 56 bytes inside a block of size 62 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x69706D6F632F6C60: ??? ==102997== by 0x746E492F7372656B: ??? ==102997== by 0x6F706D6F632F6C64: ??? ==102997== by 0x325F65785F726572: ??? ==102997== by 0x37302E302E33312F: ??? ==102997== by 0x6E692F6E69622F38: ??? ==102997== by 0x752F0034366C6573: ??? ==102997== by 0x6C61636F6C2F7272: ??? ==102997== by 0x6567616B6361702E: ??? ==102997== by 0x706D6E65706F2F72: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x637eb90 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== Address 0x637ec68 is 56 bytes inside a block of size 62 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x69706D6F632F6C60: ??? ==102997== by 0x746E492F7372656B: ??? ==102997== by 0x6F706D6F632F6C64: ??? ==102997== by 0x325F65785F726572: ??? ==102997== by 0x37302E302E33312F: ??? ==102997== by 0x6E692F6E69622F38: ??? ==102997== by 0x752F0034366C6573: ??? ==102997== by 0x6C61636F6C2F7272: ??? ==102997== by 0x6567616B6361702E: ??? ==102997== by 0x706D6E65706F2F72: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E985: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== Address 0x6380418 is 56 bytes inside a block of size 57 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E985: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== Address 0x6380418 is 56 bytes inside a block of size 57 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E963: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== Address 0x63804e8 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 4 ==102997== at 0x40E9FA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== Address 0x637eee4 is 4 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x732F3A6E69622F71: ??? ==102997== by 0x7273752F3A6E6961: ??? ==102997== by 0x752F3A6E6962732E: ??? ==102997== by 0x6C61636F6C2F7272: ??? ==102997== by 0x73752F3A6E69622E: ??? ==102997== by 0x2F6C61636F6C2F71: ??? ==102997== by 0x73752F3A6E696272: ??? ==102997== by 0x2F36523131582F71: ??? ==102997== by 0x7273752F3A6E6961: ??? ==102997== by 0x702F6C61636F6C2E: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E963: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== Address 0x63804e8 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E963: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== Address 0x63804e8 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BB7C: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6380658 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BB7C: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2ED2: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6389c50 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2ED2: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6389ca8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2EFF: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6389ea0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2EFF: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6389ef8 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2F2C: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638a0f0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2F2C: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638a148 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2F56: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638a340 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2F56: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638a390 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2F56: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2F83: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638a570 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2F83: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638a5c0 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2F83: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2FB0: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638a7a0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2FB0: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638a7f0 is 0 bytes inside a block of size 7 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2FB0: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2FDA: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638a9d0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2FDA: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638aa28 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B2FDA: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B3004: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638ac00 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B3004: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638ac58 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B306D: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638ae40 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B306D: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638ae98 is 8 bytes inside a block of size 11 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B3092: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638b070 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B3092: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638b0c8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B30FE: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638b2b0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B30FE: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638b308 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B3129: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638b510 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B3129: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638b568 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B31FD: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638b830 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B3227: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638bad0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B329F: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638bd30 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B329F: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638bd88 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B3372: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638bf90 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B3372: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638bfe8 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B342A: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638c1c0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B342A: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638c218 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BC46: orte_rml_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634B2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x638ca08 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7BC46: orte_rml_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634B2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E3D4: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB2A3B: opal_ifindextoname (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x86B66BB: mca_oob_tcp_component_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x4C6E857: mca_oob_base_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x79698F1: rml_oob_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4C7BCC4: orte_rml_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634B2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8ED0B06: orte_routed_radix_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_radix.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7C9A4: orte_routed_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634D0: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63b2530 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8ED0B06: orte_routed_radix_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_radix.so) ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7C9A4: orte_routed_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75634D0: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C749A0: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63c7cb0 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C7487A: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C749FE: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63c7cb0 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C7487A: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB65BE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6722: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6722: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBB3: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 4 ==102997== at 0x40E9FA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63c97ac is 12 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74A48: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EA17: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAC821: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63c97a8 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74A48: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAC821: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A08D4C: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4A08D53: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4A08D56: memcpy (mc_replace_strmem.c:882) ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAC833: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63cae38 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAC886: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63cae38 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAC8E8: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63cae38 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCAC01: orte_ras_loadleveler_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_loadleveler.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63dc798 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCAC01: orte_ras_loadleveler_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_loadleveler.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63dc7e8 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8ECCED1: ras_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_slurm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63dca50 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8ECCED1: ras_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_slurm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63dcaa8 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x90CFCEC: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63dccf0 is 0 bytes inside a block of size 3 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x90CFCEC: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63dcd48 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x90CFD62: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63dd000 is 0 bytes inside a block of size 3 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x90CFD62: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63dd058 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x90CFD62: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7905A: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63dd698 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C790A0: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63dd878 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C792AB: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63de568 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C792EC: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63de788 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EA83: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E32C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x92D3580: orte_rmaps_resilient_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rmaps_resilient.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63f8b48 is 8 bytes inside a block of size 10 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x92D3580: orte_rmaps_resilient_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rmaps_resilient.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63f8b98 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x92D3580: orte_rmaps_resilient_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rmaps_resilient.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CD2862: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CD286B: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CD2877: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CD2881: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CD28A2: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CD209F: look_sysfsnode (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCBF03: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CD20AF: look_sysfsnode (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCBF03: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CD20AB: look_sysfsnode (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCBF03: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E774: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E8C9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E8D8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E8E4: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E8E9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD72A: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD73B: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD740: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD756: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCD758: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CDB9A8: opal_hwloc132_hwloc_obj_add_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCD76D: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD72A: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD73B: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD740: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD756: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCD758: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC1C8: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC1D9: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC1DE: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC1F4: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCC1F6: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC359: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC36A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC36F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC385: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCC387: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC67B: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC68C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC691: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC6A7: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCC6A9: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC80C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC81D: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC822: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC838: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCC83A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC99D: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC9AE: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC9B3: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCC9C9: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCC9CB: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCCB2E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCCB3F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCCB44: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCCB5A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCCB5C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCCE50: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCCE61: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCCE66: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCCE7C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCCE7E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCCFE1: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCCFF2: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCCFF7: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD00D: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCD00F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD172: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD183: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD188: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD19E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCD1A0: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD303: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD314: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD319: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD32F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCD331: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD49E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD4AF: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD4B4: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CCD4CA: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CCD4CC: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x7765C25: query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_sysinfo_linux.so) ==102997== by 0x4CF2782: opal_sysinfo_base_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C664D2: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6368e78 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C66542: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64ad018 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E3C0: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C665D1: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C47EDB: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6331ab8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C0E357: ??? ==102997== by 0x7FEFFEA8F: ??? ==102997== by 0x7FEFFEAB7: ??? ==102997== by 0x4C0DFFF: ??? (in /usr/lib64/valgrind/vgpreload_memcheck-amd64-linux.so) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48024: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b5e60 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4C47FC9: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 4 ==102997== at 0x40E9CB: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48024: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b5f60 is 0 bytes inside a block of size 2 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4C47FE7: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48024: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b6130 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB65CA: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EA83: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EA98: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EAB8: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EB8D: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EB92: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EB96: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C48146: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b6130 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x736E6F6973736572: ??? ==102997== by 0x31756F76616B732C: ??? ==102997== by 0x323733656B696D3F: ??? ==102997== by 0x305E: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5FE0: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b61b0 is 48 bytes inside a block of size 52 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5FE0: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6158: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6158: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB60EE: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x4CB60FB: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6114: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6114: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b63e0 is 32 bytes inside a block of size 35 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x736E6F6973736572: ??? ==102997== by 0x31756F76616B732C: ??? ==102997== by 0x323733656B696D3F: ??? ==102997== by 0x305E: ??? ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB60FA: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6114: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 4 ==102997== at 0x40E9FA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b6494 is 4 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x736E6F6973736572: ??? ==102997== by 0x31756F76616B732C: ??? ==102997== by 0x323733656B696D3F: ??? ==102997== by 0x305E: ??? ==102997== ==102997== Invalid read of size 4 ==102997== at 0x40E9CB: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b6550 is 0 bytes inside a block of size 2 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x736E6F6973736572: ??? ==102997== by 0x31756F76616B732C: ??? ==102997== by 0x323733656B696D3F: ??? ==102997== by 0x305E: ??? ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E985: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b6690 is 48 bytes inside a block of size 50 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4CB5FEB: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C47C16: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b6270 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x7563962: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6331ab8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C0E357: ??? ==102997== by 0x7FEFFEA8F: ??? ==102997== by 0x7FEFFEAB7: ??? ==102997== by 0x4C0DFFF: ??? (in /usr/lib64/valgrind/vgpreload_memcheck-amd64-linux.so) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E5BD: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4F9F90: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64caa30 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4F9F90: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64caa88 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4F9FC4: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cac60 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4F9FC4: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cacb8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cae90 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64caee0 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cb160 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cb1b0 is 0 bytes inside a block of size 3 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA09B: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cb440 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA09B: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cb490 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA09B: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA0CB: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cb720 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA0CB: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cb778 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA11C: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cb970 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA4FA11C: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cb9c8 is 8 bytes inside a block of size 13 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5E693: orte_filem_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AB1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C45748: orte_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AE2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64cd3b8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA701A60: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64d65d8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA701A60: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64d6620 is 0 bytes inside a block of size 4 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA5C48: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA701A60: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA701A94: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64d6918 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA701A94: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64d6968 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA701AC8: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64d6b58 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0xA701AC8: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64d6ba8 is 8 bytes inside a block of size 9 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C65812: orte_notifier_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7563AFC: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EA47: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x90CFE39: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x63dd1f0 is 16 bytes inside a block of size 22 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x90CFE9A: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x90CFEAE: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x90CFEB7: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x90D0015: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x90D0021: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x90D0025: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x90D002E: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C52A7A: orte_util_encode_nodemap (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6CBD4: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b7fe8 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C52AA6: orte_util_encode_nodemap (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6CBD4: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64ea868 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C8751A: opal_dss_pack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C871E3: opal_dss_pack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C52B13: orte_util_encode_nodemap (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6CBD4: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64ea868 is 0 bytes after a block of size 8 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C87536: opal_dss_pack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C871E3: opal_dss_pack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7C40C: orte_rml_base_get_contact_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7B70485: get_wireup_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_binomial.so) ==102997== by 0x4C6CCAC: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b8580 is 64 bytes inside a block of size 65 alloc'd ==102997== at 0x4A06C20: realloc (vg_replace_malloc.c:662) ==102997== by 0x3C8BA6F3D2: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x7969BD8: orte_rml_oob_get_uri (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x7563A05: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x404DBC: orterun (orterun.c:693) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4C8751A: opal_dss_pack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C3FCA2: orte_dt_pack_app_context (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C871E3: opal_dss_pack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6D114: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61a0e38 is 8 bytes inside a block of size 12 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x2E36342E30392E33: ??? ==102997== by 0x313436353A383130: ??? ==102997== by 0x400031: ??? (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x86B5450: mca_oob_tcp_parse_uri (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x86B51DF: mca_oob_tcp_set_addr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) ==102997== by 0x7969C83: orte_rml_oob_set_uri (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) ==102997== by 0x4C7C4EA: orte_rml_base_update_contact_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7B705E5: init_routes (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_binomial.so) ==102997== by 0x4C6C86F: orte_odls_base_default_update_daemon_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A912: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== Address 0x64ed998 is 24 bytes inside a block of size 26 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB5A68: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== Address 0x64f00a8 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E757: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5AAB: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== Address 0x64f00a8 is 8 bytes inside a block of size 15 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5A84: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== Address 0x64f17e0 is 16 bytes inside a block of size 20 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB5910: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== Address 0x61a39a8 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x535300303030313C: ??? ==102997== by 0x544E45494C435F47: ??? ==102997== by 0x2E3532312E36393C: ??? ==102997== by 0x332035392E323130: ??? ==102997== by 0x32322038383232: ??? ==102997== by 0x52415F435354454F: ??? ==102997== by 0x5000656E6F3D4842: ??? ==102997== by 0x414E424F4A5F5341: ??? ==102997== by 0x6F73696E613D454C: ??? ==102997== by 0x5952415242494BFF: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5967: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== Address 0x61a39a8 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x535300303030313C: ??? ==102997== by 0x544E45494C435F47: ??? ==102997== by 0x2E3532312E36393C: ??? ==102997== by 0x332035392E323130: ??? ==102997== by 0x32322038383232: ??? ==102997== by 0x52415F435354454F: ??? ==102997== by 0x5000656E6F3D4842: ??? ==102997== by 0x414E424F4A5F5341: ??? ==102997== by 0x6F73696E613D454C: ??? ==102997== by 0x5952415242494BFF: ??? ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5AAB: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== Address 0x64f2328 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E578: __intel_sse2_strchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5957: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== Address 0x61a42a8 is 24 bytes inside a block of size 25 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4F5449525245545E: ??? ==102997== by 0x53555F6E653D5951: ??? ==102997== by 0x2F3D434E495450FF: ??? ==102997== by 0x3662696C2F727374: ??? ==102997== by 0x332E332D74712F33: ??? ==102997== by 0x6564756C636E692E: ??? ==102997== by 0x575F4F5F53424FFF: ??? ==102997== by 0x2F3D5249444B524E: ??? ==102997== by 0x616B732F656D6F67: ??? ==102997== by 0x726F772F31756F75: ??? ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6B08C: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6B13A: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6B13A: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CA856E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D2BD: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB5A68: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D2E0: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== Address 0x65111c8 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D2E0: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5C36: opal_unsetenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D319: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== Address 0x65116d8 is 0 bytes after a block of size 24 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CB5BFE: opal_unsetenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D319: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB5C5A: opal_unsetenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5D319: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== Address 0x64f2328 is 8 bytes inside a block of size 14 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB5A68: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D98: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6512cc0 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69D98: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAC84F: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C4A436: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== Address 0x6512d20 is 16 bytes inside a block of size 19 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CAC8A2: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C4A436: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== Address 0x6512d20 is 16 bytes inside a block of size 19 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C4A464: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== Address 0x6512d80 is 16 bytes inside a block of size 17 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4C4A499: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) ==102997== by 0x405C2E: orterun (orterun.c:917) ==102997== Address 0x64eeb00 is 16 bytes inside a block of size 19 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x4C89F6D: opal_dss_unpack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8A924: opal_dss_unpack_buffer (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C41DE4: orte_dt_unpack_app_context (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C8A924: opal_dss_unpack_buffer (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C890B9: opal_dss_unpack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6C118: orte_odls_base_default_construct_child_list (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x8CCD1FD: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EA47: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x40C88C: orte_debugger_init_after_spawn (orterun.c:2904) ==102997== by 0x405C4F: orterun (orterun.c:921) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x61a3070 is 16 bytes inside a block of size 19 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA81021: strdup (in /lib64/libc-2.12.so) ==102997== by 0x40A30F: create_app (orterun.c:2180) ==102997== by 0x408ACD: parse_locals (orterun.c:1681) ==102997== by 0x404D1E: orterun (orterun.c:658) ==102997== by 0x4041A3: main (main.c:13) ==102997== [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Too many processors in X direction: 2 1 [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c [0]PETSC ERROR: PETSc Option Table entries: [0]PETSC ERROR: -ksp_gmres_restart 300 [0]PETSC ERROR: -ksp_type gmres [0]PETSC ERROR: -log_view [0]PETSC ERROR: -pc_asm_overlap 4 [0]PETSC ERROR: -pc_type asm [0]PETSC ERROR: -snes_atol 1.0e-20 [0]PETSC ERROR: -snes_linesearch_type bt [0]PETSC ERROR: -snes_mf [0]PETSC ERROR: -snes_monitor [0]PETSC ERROR: -snes_type newtontr [0]PETSC ERROR: -sub_ksp_type preonly [0]PETSC ERROR: -sub_pc_type lu [0]PETSC ERROR: -ts_adapt_monitor [0]PETSC ERROR: -ts_max_snes_failures -1 [0]PETSC ERROR: -ts_monitor [0]PETSC ERROR: -ts_type bdf [0]PETSC ERROR: -ts_view [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Too many processors in X direction: 2 1 [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c [0]PETSC ERROR: PETSc Option Table entries: [0]PETSC ERROR: -ksp_gmres_restart 300 [0]PETSC ERROR: -ksp_type gmres [0]PETSC ERROR: -log_view [0]PETSC ERROR: -pc_asm_overlap 4 [0]PETSC ERROR: -pc_type asm [0]PETSC ERROR: -snes_atol 1.0e-20 [0]PETSC ERROR: -snes_linesearch_type bt [0]PETSC ERROR: -snes_mf [0]PETSC ERROR: -snes_monitor [0]PETSC ERROR: -snes_type newtontr [0]PETSC ERROR: -sub_ksp_type preonly [0]PETSC ERROR: -sub_pc_type lu [0]PETSC ERROR: -ts_adapt_monitor [0]PETSC ERROR: -ts_max_snes_failures -1 [0]PETSC ERROR: -ts_monitor [0]PETSC ERROR: -ts_type bdf [0]PETSC ERROR: -ts_view [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Too many processors in X direction: 2 1 [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c [0]PETSC ERROR: PETSc Option Table entries: [0]PETSC ERROR: -ksp_gmres_restart 300 [0]PETSC ERROR: -ksp_type gmres [0]PETSC ERROR: -log_view [0]PETSC ERROR: -pc_asm_overlap 4 [0]PETSC ERROR: -pc_type asm [0]PETSC ERROR: -snes_atol 1.0e-20 [0]PETSC ERROR: -snes_linesearch_type bt [0]PETSC ERROR: -snes_mf [0]PETSC ERROR: -snes_monitor [0]PETSC ERROR: -snes_type newtontr [0]PETSC ERROR: -sub_ksp_type preonly [0]PETSC ERROR: -sub_pc_type lu [0]PETSC ERROR: -ts_adapt_monitor [0]PETSC ERROR: -ts_max_snes_failures -1 [0]PETSC ERROR: -ts_monitor [0]PETSC ERROR: -ts_type bdf [0]PETSC ERROR: -ts_view [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- [0]PETSC ERROR: Argument out of range [0]PETSC ERROR: Too many processors in X direction: 2 1 [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c [0]PETSC ERROR: PETSc Option Table entries: [0]PETSC ERROR: -ksp_gmres_restart 300 [0]PETSC ERROR: -ksp_type gmres [0]PETSC ERROR: -log_view [0]PETSC ERROR: -pc_asm_overlap 4 [0]PETSC ERROR: -pc_type asm [0]PETSC ERROR: -snes_atol 1.0e-20 [0]PETSC ERROR: -snes_linesearch_type bt [0]PETSC ERROR: -snes_mf [0]PETSC ERROR: -snes_monitor [0]PETSC ERROR: -snes_type newtontr [0]PETSC ERROR: -sub_ksp_type preonly [0]PETSC ERROR: -sub_pc_type lu [0]PETSC ERROR: -ts_adapt_monitor [0]PETSC ERROR: -ts_max_snes_failures -1 [0]PETSC ERROR: -ts_monitor [0]PETSC ERROR: -ts_type bdf [0]PETSC ERROR: -ts_view [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 [unset]: aborting job: application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 [unset]: aborting job: application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 [unset]: aborting job: application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 [unset]: aborting job: application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 ==102997== Invalid read of size 8 ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C68E02: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b66e0 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C68E02: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b6750 is 32 bytes inside a block of size 35 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C486B9: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b66e0 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x653b270 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4C486FB: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EA83: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EA98: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EAB8: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EB8D: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EB92: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EB96: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C487A3: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x653b170 is 0 bytes inside a block of size 2 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4C46EBA: orte_util_convert_vpid_to_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C486CA: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C487E2: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9B4: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C487E2: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C4844C: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x64b66e0 is 0 bytes inside a block of size 5 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C484C2: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x654ea00 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4C48476: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C484C2: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA2DE: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== Address 0x654f550 is 16 bytes inside a block of size 23 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA410: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== Address 0x654fd40 is 64 bytes inside a block of size 67 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA44F: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA44F: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== Address 0x654fd40 is 64 bytes inside a block of size 67 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA479: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA479: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== ==102997== Invalid read of size 8 ==102997== at 0x40EA47: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== Address 0x654fe68 is 24 bytes inside a block of size 28 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA499: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CBA499: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) ==102997== by 0x405E74: job_completed (orterun.c:957) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== -------------------------------------------------------------------------- mpiexec noticed that the job aborted, but has no info as to the process that caused that situation. -------------------------------------------------------------------------- ==102997== Invalid read of size 8 ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C484EC: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4063E5: just_quit (orterun.c:1046) ==102997== by 0x406302: job_completed (orterun.c:1016) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== Address 0x6550f20 is 0 bytes inside a block of size 6 alloc'd ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) ==102997== by 0x4C48476: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4063E5: just_quit (orterun.c:1046) ==102997== by 0x406302: job_completed (orterun.c:1016) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C484EC: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4063E5: just_quit (orterun.c:1046) ==102997== by 0x406302: job_completed (orterun.c:1016) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x405C54: orterun (orterun.c:925) ==102997== by 0x4041A3: main (main.c:13) ==102997== ==102997== Use of uninitialised value of size 8 ==102997== at 0x40EBB3: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C4853B: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4063E5: just_quit (orterun.c:1046) ==102997== by 0x406302: job_completed (orterun.c:1016) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== Conditional jump or move depends on uninitialised value(s) ==102997== at 0x40EA59: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C4853B: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4063E5: just_quit (orterun.c:1046) ==102997== by 0x406302: job_completed (orterun.c:1016) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) ==102997== ==102997== ==102997== HEAP SUMMARY: ==102997== in use at exit: 411,245 bytes in 3,053 blocks ==102997== total heap usage: 8,975 allocs, 5,922 frees, 12,560,021 bytes allocated ==102997== ==102997== LEAK SUMMARY: ==102997== definitely lost: 52,793 bytes in 43 blocks ==102997== indirectly lost: 17,831 bytes in 61 blocks ==102997== possibly lost: 0 bytes in 0 blocks ==102997== still reachable: 340,621 bytes in 2,949 blocks ==102997== suppressed: 0 bytes in 0 blocks ==102997== Rerun with --leak-check=full to see details of leaked memory ==102997== ==102997== For counts of detected and suppressed errors, rerun with: -v ==102997== Use --track-origins=yes to see where uninitialised values come from ==102997== ERROR SUMMARY: 45427 errors from 796 contexts (suppressed: 6 from 6) -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Wed Jul 19 10:32:16 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Wed, 19 Jul 2017 10:32:16 -0500 Subject: [petsc-users] error in DMDACreate3d In-Reply-To: References: Message-ID: <0B565A8A-C344-42C2-8A02-910D1FB6F6C7@mcs.anl.gov> Sepideh, All of the valgrind messages are from OpenMPI (it is horribly not valgrind clean; you should use --download-mpich if you want to use MPI with valgrind). Please send the output from running on both systems without valgrind. I want to see the exact error message. Are you running with -pc_type mg ? Barry > On Jul 19, 2017, at 10:10 AM, Sepideh Kavousi wrote: > > Hi, > I am writing a petsc code where I create a 3d da object using DMDACreate3d, I want to have 2 processors in x , 1 processor in y and 2 processors in z direction. for this I write: > > ierr= DMDACreate3d(PETSC_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_BOX, > 60,60,60,2,1,2,2,1,llx,lly,llz,&da2) ;CHKERRQ(ierr); > and llx and lly and llz are as : llx[2]={30,30},lly[1]={60},llz[2]={30,30} > it works fine when I run with my personal workstation. But when I want to run it on hpc it gives an error. and by running with valgrind it gives the following error. I do not understand why it says: Too many processors in X direction: 2 1. Can some one please help me about it? > Thanks, > Sepideh > > > > ==102997== Memcheck, a memory error detector > ==102997== Copyright (C) 2002-2012, and GNU GPL'd, by Julian Seward et al. > ==102997== Using Valgrind-3.8.1 and LibVEX; rerun with -h for copyright info > ==102997== Command: mpiexec -n 4 ./try3-jacob-3.out -ts_monitor -snes_monitor -snes_mf -log_view -ts_max_snes_failures -1 -ts_type bdf -snes_type newtontr -pc_type asm -ksp_gmres_restart 300 -sub_ksp_type preonly -sub_pc_type lu -pc_asm_overlap 4 -ts_adapt_monitor -snes_linesearch_type bt -ksp_type gmres -snes_atol 1.0e-20 -snes_monitor -ts_view -ts_adapt_monitor > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAC833: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40446C: orterun (orterun.c:494) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61528f8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x742F2E0034006E2C: ??? > ==102997== by 0x6F63616A2D337971: ??? > ==102997== by 0x74756F2E332D61: ??? > ==102997== by 0x696E6F6D5F73742C: ??? > ==102997== by 0x656E732D00726F73: ??? > ==102997== by 0x6F74696E6F6D5F72: ??? > ==102997== by 0x5F73656E732D0071: ??? > ==102997== by 0x5F676F6C2D00666C: ??? > ==102997== by 0x73742D0077656975: ??? > ==102997== by 0x656E735F78616D5E: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAC886: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40446C: orterun (orterun.c:494) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61528f8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x742F2E0034006E2C: ??? > ==102997== by 0x6F63616A2D337971: ??? > ==102997== by 0x74756F2E332D61: ??? > ==102997== by 0x696E6F6D5F73742C: ??? > ==102997== by 0x656E732D00726F73: ??? > ==102997== by 0x6F74696E6F6D5F72: ??? > ==102997== by 0x5F73656E732D0071: ??? > ==102997== by 0x5F676F6C2D00666C: ??? > ==102997== by 0x73742D0077656975: ??? > ==102997== by 0x656E735F78616D5E: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAD821: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044E1: orterun (orterun.c:500) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x615ce50 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F63616A2D337971: ??? > ==102997== by 0x74756F2E332D61: ??? > ==102997== by 0x696E6F6D5F73742C: ??? > ==102997== by 0x656E732D00726F73: ??? > ==102997== by 0x6F74696E6F6D5F72: ??? > ==102997== by 0x5F73656E732D0071: ??? > ==102997== by 0x5F676F6C2D00666C: ??? > ==102997== by 0x73742D0077656975: ??? > ==102997== by 0x656E735F78616D5E: ??? > ==102997== by 0x72756C6961665F72: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAD9D5: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044E1: orterun (orterun.c:500) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x615ce50 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F63616A2D337971: ??? > ==102997== by 0x74756F2E332D61: ??? > ==102997== by 0x696E6F6D5F73742C: ??? > ==102997== by 0x656E732D00726F73: ??? > ==102997== by 0x6F74696E6F6D5F72: ??? > ==102997== by 0x5F73656E732D0071: ??? > ==102997== by 0x5F676F6C2D00666C: ??? > ==102997== by 0x73742D0077656975: ??? > ==102997== by 0x656E735F78616D5E: ??? > ==102997== by 0x72756C6961665F72: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CABAF8: opal_argv_append_nosize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CABB75: opal_argv_append (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAD38B: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044E1: orterun (orterun.c:500) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x615cf00 is 0 bytes inside a block of size 2 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x332D626F63616A2C: ??? > ==102997== by 0x73742D0074756F2D: ??? > ==102997== by 0x726F74696E6F6D5E: ??? > ==102997== by 0x6D5F73656E732CFF: ??? > ==102997== by 0x2D00726F74696E6E: ??? > ==102997== by 0x666D5F73656E72: ??? > ==102997== by 0x6569765F676F6C2C: ??? > ==102997== by 0x616D5F73742D0076: ??? > ==102997== by 0x665F73656E735F77: ??? > ==102997== by 0x736572756C6960: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EF46: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== Address 0x615cfd0 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E332D626F6360: ??? > ==102997== by 0x6D5F73742D007474: ??? > ==102997== by 0x2D00726F74696E6E: ??? > ==102997== by 0x6E6F6D5F73656E72: ??? > ==102997== by 0x6E732D00726F7468: ??? > ==102997== by 0x6C2D00666D5F7364: ??? > ==102997== by 0x776569765F676E: ??? > ==102997== by 0x5F78616D5F73742C: ??? > ==102997== by 0x6961665F73656E72: ??? > ==102997== by 0x312D00736572756B: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CABAF8: opal_argv_append_nosize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CABB75: opal_argv_append (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAD600: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044E1: orterun (orterun.c:500) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x615d098 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x656E732D00726F73: ??? > ==102997== by 0x6F74696E6F6D5F72: ??? > ==102997== by 0x5F73656E732D0071: ??? > ==102997== by 0x5F676F6C2D00666C: ??? > ==102997== by 0x73742D0077656975: ??? > ==102997== by 0x656E735F78616D5E: ??? > ==102997== by 0x72756C6961665F72: ??? > ==102997== by 0x742D00312D007364: ??? > ==102997== by 0x6200657079745F72: ??? > ==102997== by 0x73656E732D006663: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB698C: opal_output_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9023: opal_output_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84BBD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6161a80 is 16 bytes inside a block of size 18 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB8E9E: opal_output_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84BBD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6164d48 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAACDD: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61650b0 is 16 bytes inside a block of size 23 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA6F6A3: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA756C4: _IO_str_init_static_internal (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F703: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7455B: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7456F: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74578: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74582: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74670: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA745E5: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA48160: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0A02A: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0A033: mempcpy (mc_replace_strmem.c:128) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0A048: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0A095: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A0A0A8: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A0A0AC: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0A0BB: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A0A0BB: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x3C8BA6F71E: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAACDD: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61656f0 is 16 bytes inside a block of size 21 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA6F6A3: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x3C8BA6F71E: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAACDD: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6165ce8 is 24 bytes inside a block of size 27 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA6F6A3: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x3C8BA6F71E: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08B6A: memcpy (mc_replace_strmem.c:119) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08B8C: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08C18: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08C3E: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08C5B: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08C6C: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08C80: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08C8C: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08C98: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08CB2: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08CB8: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08CBF: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08CCA: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB510C: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB511A: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A06BAE: realloc (vg_replace_malloc.c:662) > ==102997== by 0x4CB5137: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB5164: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB517C: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E3B5: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E410: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== > ==102997== More than 100 errors detected. Subsequent errors > ==102997== will still be recorded, but in less detail than before. > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E41D: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E4EC: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E502: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB518B: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAB8E9: save_value (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB52E6: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D03: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D09: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08D21: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08D28: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D2A: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D13: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D30: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D76: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CABAF8: opal_argv_append_nosize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CABB75: opal_argv_append (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CABD1F: opal_argv_split (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB5630: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617be00 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x3C8BA74667: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAE55: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617bb58 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C84F41: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617c038 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55D0: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55D0: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55DD: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55DD: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85027: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617c238 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7458C: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85027: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF201F: opal_shmem_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8503E: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617c418 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA560D: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF201F: opal_shmem_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8503E: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF8F8: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617d198 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA7356: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA7356: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA7370: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA7370: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA737C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA737C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA73A8: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF9B7: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617d9d8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA844D: mca_base_param_lookup_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBCC96: opal_util_register_stackhandlers (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CB2: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617bf28 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA82F4: mca_base_param_lookup_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBCC96: opal_util_register_stackhandlers (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CB2: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617dd18 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5557: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBD0B0: opal_util_init_sys_limits (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CCB: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617de60 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA621A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617e070 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617e0c0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62C7: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62C7: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62E2: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62E2: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA630A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA630A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6317: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6317: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA621A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617e238 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617e280 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA630A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6317: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6347: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6236: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB67: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617f550 is 16 bytes inside a block of size 17 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB67: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617f5a0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42E29: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6180ff8 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42E29: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6181058 is 24 bytes inside a block of size 31 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CAACE8: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42E29: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42E7C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6181408 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42EBD: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61815f0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42EBD: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42F08: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61817e8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42F2E: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61819d8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4315F: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6184ff8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C431A0: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61851f8 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA560D: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C431A0: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6185258 is 24 bytes inside a block of size 31 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CA5562: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C431A0: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C431EB: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61853e8 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43245: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6185818 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43298: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6185c30 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43298: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C432D9: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6185e18 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43339: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6186028 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C433E1: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6186508 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43432: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6186728 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43511: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6186de8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43511: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA7356: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43530: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C435AA: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61874a8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C435EB: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6187688 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43643: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6187878 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43689: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6187a68 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43689: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C437A6: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61882d8 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C437F2: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61884d8 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8E12: param_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAAF43: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C437F2: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61885f0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8CCF: param_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAAF43: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C437F2: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6188640 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43860: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61889b0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43860: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C438EE: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6188e18 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C438EE: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA739C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43910: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA739C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4392B: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43A3C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6189c78 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43A3C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43A6C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6189e48 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43A6C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43A95: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x618e478 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43AD1: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x618e648 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43B0D: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x618e818 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43B0D: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43D03: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x618edf8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43D4B: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x618efd8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAD9D5: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4092E9: create_app (orterun.c:1908) > ==102997== by 0x408ACD: parse_locals (orterun.c:1681) > ==102997== by 0x404D1E: orterun (orterun.c:658) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x619c0f0 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4826: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61ae808 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4871: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA48C5: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af098 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA48C5: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA48FA: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af200 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4933: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af250 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4982: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af250 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6C67: opal_output_reopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C03: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af360 is 16 bytes inside a block of size 18 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA4BF7: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8EB45: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F942: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af548 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8B6C2: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F92A: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8FAA6: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af598 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F942: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8FBE5: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af598 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F942: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C9172F: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af5e0 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C9179A: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af5e0 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8B67F: lt__strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af638 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9175B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8B68F: lt__strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0937A: _intel_fast_memcpy (mc_replace_strmem.c:119) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0939C: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09513: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09519: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09531: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09538: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0953A: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09540: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A0955C: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09563: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09566: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09586: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C92C11: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af5e0 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E2D8: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92DD2: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af5e4 is 4 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E2E4: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92DD2: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af5e4 is 4 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D22: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D22: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFAB7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af968 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA43F0: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3E4A: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b09d8 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8E79B: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0cc8 is 56 bytes inside a block of size 59 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA8AEE2: argz_create_sep (in /lib64/libc-2.12.so) > ==102997== by 0x4C8E710: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E31C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8E809: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0cc8 is 56 bytes inside a block of size 59 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA8AEE2: argz_create_sep (in /lib64/libc-2.12.so) > ==102997== by 0x4C8E710: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C919D5: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0d48 is 56 bytes inside a block of size 60 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E7D1: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C919D5: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4C919D6: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91A66: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0d48 is 56 bytes inside a block of size 60 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E7D1: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91A66: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E31C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0d48 is 56 bytes inside a block of size 60 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E7D1: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E32C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E33C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E345: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E35C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E373: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E38C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91BAA: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91BAA: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EC15: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91BB8: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC37: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91BB8: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91BB8: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4C91BB9: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91E19: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b8e48 is 72 bytes inside a block of size 73 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91B6C: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E5B8: __intel_sse2_strend (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91C66: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61bbcd0 is 1,088 bytes inside a block of size 1,091 alloc'd > ==102997== at 0x4A06C20: realloc (vg_replace_malloc.c:662) > ==102997== by 0x3C8BA8B16F: argz_insert (in /lib64/libc-2.12.so) > ==102997== by 0x4C91C9D: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E5B8: __intel_sse2_strend (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91D8D: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6201eb8 is 6,312 bytes inside a block of size 6,314 alloc'd > ==102997== at 0x4A06C20: realloc (vg_replace_malloc.c:662) > ==102997== by 0x3C8BA8B16F: argz_insert (in /lib64/libc-2.12.so) > ==102997== by 0x4C91C9D: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E5B8: __intel_sse2_strend (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8E8A7: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0cc8 is 56 bytes inside a block of size 59 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA8AEE2: argz_create_sep (in /lib64/libc-2.12.so) > ==102997== by 0x4C8E710: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E578: __intel_sse2_strchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA1DC4: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0bc8 is 88 bytes inside a block of size 93 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8E6A2: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0bc8 is 88 bytes inside a block of size 93 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA17BE: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA189F: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6202798 is 72 bytes inside a block of size 76 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E5DA: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E601: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E677: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA621A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x620e438 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x620e488 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62C7: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E6C8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6207c18 is 72 bytes inside a block of size 79 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E774: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8C1: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8C9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8D8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA1988: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CA198A: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E3C0: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6207c1c is 76 bytes inside a block of size 79 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E3C8: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6207c1c is 76 bytes inside a block of size 79 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E449: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19F5: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6207c18 is 72 bytes inside a block of size 79 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E477: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA1A4C: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6207c18 is 72 bytes inside a block of size 79 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E4: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EB61: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C693: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x62116a0 is 80 bytes inside a block of size 82 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C660: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8C833: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6211740 is 80 bytes inside a block of size 82 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C693: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8C973: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6211740 is 80 bytes inside a block of size 82 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C693: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8D5C6: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6212438 is 56 bytes inside a block of size 59 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F50B: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8D633: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6212340 is 16 bytes inside a block of size 23 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F5BD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8B69B: lt__strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D702: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6212570 is 80 bytes inside a block of size 82 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D645: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA27FB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92BAA: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92C2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6211820 is 16 bytes inside a block of size 20 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C9CA: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C92C41: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E2FA: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92DD2: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6211820 is 16 bytes inside a block of size 20 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C9CA: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D22: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA59: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA98: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EAB8: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB8D: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB92: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EB96: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E30A: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E33C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E345: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E35C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E373: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E38C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6213710 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6213768 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FB7: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FB7: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FD2: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FD2: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5007: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5007: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5037: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6214b60 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4F59: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6214bc0 is 16 bytes inside a block of size 20 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FFA: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FFA: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5007: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5037: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6214c38 is 40 bytes inside a block of size 46 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CA4F64: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF41D: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6214de0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF449: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x62150e0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF475: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x62153e0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEBAC2: opal_memory_linux_hook_pull (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF5E7: opal_memory_linux_ptmalloc2_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF4D6: linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6215710 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEBAC2: opal_memory_linux_hook_pull (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF5E7: opal_memory_linux_ptmalloc2_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF4D6: linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6215768 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE62C9: opal_memchecker_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A61: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6315bd8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55DD: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE62C9: opal_memchecker_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A61: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E774: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8C9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8D8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E4: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDE5F: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6317f38 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E449: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6203110 is 80 bytes inside a block of size 81 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E477: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19F5: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6203110 is 80 bytes inside a block of size 81 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7455B: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7456F: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74578: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74582: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74670: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA745E5: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA440F3: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7455B: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7456F: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74578: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74582: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x3C8BA74667: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74670: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA745E5: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA445F0: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E924: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EEA1: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E93F: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EEA1: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EEDB: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8EF1B: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8EF24: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8EF2E: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0937A: _intel_fast_memcpy (mc_replace_strmem.c:119) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0939C: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09513: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09595: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A095FC: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A095FF: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09601: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4C8F4EB: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E924: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EFBD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E93F: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EFBD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EFF7: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8F031: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8F03A: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8F044: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0937A: _intel_fast_memcpy (mc_replace_strmem.c:119) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0939C: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09513: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09519: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09531: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09538: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0953A: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09523: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09540: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A0955C: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09563: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09566: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09586: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4C8F544: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C92C11: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x631f078 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C9CA: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6F58B51: auto_detect_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_auto_detect.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6320d18 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6F58B51: auto_detect_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_auto_detect.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6320d68 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FFA: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6F58B51: auto_detect_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_auto_detect.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6320fd0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6321020 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C05: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C05: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C20: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C20: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C48: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C48: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DBA9: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6321200 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DBA9: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6321258 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9F0E2: opal_event_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AF7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6321908 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B212: mmap_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f120 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B280: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f380 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B280: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f3d8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2A9: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f700 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f990 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5BA2: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f9f0 is 16 bytes inside a block of size 22 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C85: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632fa68 is 40 bytes inside a block of size 46 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CA5BAE: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C85: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x735DFDC: posix_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_posix.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632fd00 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x735DFDC: posix_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_posix.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632fd58 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7560CAC: sysv_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_sysv.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632ffb0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7560CAC: sysv_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_sysv.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6330008 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85CB1: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6330308 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85D36: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63304e8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EEB2: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85D36: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85D36: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85D98: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63306c8 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85E6D: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6330d28 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85ED7: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6330f30 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85ED7: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85F2C: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331158 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85FBF: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331358 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C475E9: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63315c8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C475E9: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C476C2: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331998 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C476C2: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C476FD: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47739: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331bb8 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47739: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4777C: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331d98 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E424: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x620466c is 76 bytes inside a block of size 77 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E42C: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x620466c is 76 bytes inside a block of size 77 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8D617: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x634c6d8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F5BD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6347: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x635bf28 is 24 bytes inside a block of size 30 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CA6274: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637cbb0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637cc08 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FB7: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969BC3: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637cdf0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969BC3: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637ce48 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969C04: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d040 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969C04: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d098 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969C45: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d290 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969C45: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d2e8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969C86: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d4f0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969CC7: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d740 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D12: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d9a0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D12: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d9f8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D3E: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637dc60 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D3E: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637dcb0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D3E: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D60: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637de90 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D60: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637dee8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637e120 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637e170 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C05: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74DB2: plm_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637e640 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74DB2: plm_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C74769: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637ea40 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C747C8: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637ea40 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F76616B732F6B71: ??? > ==102997== by 0x74706164612F3174: ??? > ==102997== by 0x796C754A2F657668: ??? > ==102997== by 0x6D756E2D656E6F2E: ??? > ==102997== by 0x366E6F6974616562: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB65CA: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x637ec68 is 56 bytes inside a block of size 62 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x69706D6F632F6C60: ??? > ==102997== by 0x746E492F7372656B: ??? > ==102997== by 0x6F706D6F632F6C64: ??? > ==102997== by 0x325F65785F726572: ??? > ==102997== by 0x37302E302E33312F: ??? > ==102997== by 0x6E692F6E69622F38: ??? > ==102997== by 0x752F0034366C6573: ??? > ==102997== by 0x6C61636F6C2F7272: ??? > ==102997== by 0x6567616B6361702E: ??? > ==102997== by 0x706D6E65706F2F72: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637eb90 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x637ec68 is 56 bytes inside a block of size 62 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x69706D6F632F6C60: ??? > ==102997== by 0x746E492F7372656B: ??? > ==102997== by 0x6F706D6F632F6C64: ??? > ==102997== by 0x325F65785F726572: ??? > ==102997== by 0x37302E302E33312F: ??? > ==102997== by 0x6E692F6E69622F38: ??? > ==102997== by 0x752F0034366C6573: ??? > ==102997== by 0x6C61636F6C2F7272: ??? > ==102997== by 0x6567616B6361702E: ??? > ==102997== by 0x706D6E65706F2F72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E985: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x6380418 is 56 bytes inside a block of size 57 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E985: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x6380418 is 56 bytes inside a block of size 57 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E963: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x63804e8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E9FA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x637eee4 is 4 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x732F3A6E69622F71: ??? > ==102997== by 0x7273752F3A6E6961: ??? > ==102997== by 0x752F3A6E6962732E: ??? > ==102997== by 0x6C61636F6C2F7272: ??? > ==102997== by 0x73752F3A6E69622E: ??? > ==102997== by 0x2F6C61636F6C2F71: ??? > ==102997== by 0x73752F3A6E696272: ??? > ==102997== by 0x2F36523131582F71: ??? > ==102997== by 0x7273752F3A6E6961: ??? > ==102997== by 0x702F6C61636F6C2E: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E963: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x63804e8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E963: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x63804e8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BB7C: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6380658 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BB7C: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2ED2: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6389c50 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2ED2: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6389ca8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2EFF: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6389ea0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2EFF: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6389ef8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F2C: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a0f0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F2C: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a148 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F56: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a340 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F56: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a390 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F56: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F83: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a570 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F83: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a5c0 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F83: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FB0: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a7a0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FB0: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a7f0 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FB0: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FDA: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a9d0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FDA: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638aa28 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FDA: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3004: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638ac00 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3004: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638ac58 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B306D: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638ae40 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B306D: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638ae98 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3092: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b070 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3092: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b0c8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B30FE: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b2b0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B30FE: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b308 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3129: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b510 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3129: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b568 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B31FD: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b830 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3227: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638bad0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B329F: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638bd30 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B329F: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638bd88 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3372: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638bf90 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3372: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638bfe8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B342A: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638c1c0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B342A: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638c218 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BC46: orte_rml_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634B2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638ca08 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BC46: orte_rml_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634B2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E3D4: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB2A3B: opal_ifindextoname (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B66BB: mca_oob_tcp_component_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4C6E857: mca_oob_base_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x79698F1: rml_oob_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4C7BCC4: orte_rml_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634B2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8ED0B06: orte_routed_radix_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_radix.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7C9A4: orte_routed_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634D0: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63b2530 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8ED0B06: orte_routed_radix_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_radix.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7C9A4: orte_routed_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634D0: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C749A0: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63c7cb0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C7487A: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C749FE: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63c7cb0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C7487A: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB65BE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6722: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6722: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB3: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E9FA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63c97ac is 12 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74A48: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA17: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAC821: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63c97a8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74A48: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAC821: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08D4C: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08D53: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D56: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAC833: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63cae38 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAC886: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63cae38 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAC8E8: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63cae38 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCAC01: orte_ras_loadleveler_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_loadleveler.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dc798 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCAC01: orte_ras_loadleveler_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_loadleveler.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dc7e8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8ECCED1: ras_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dca50 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8ECCED1: ras_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dcaa8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFCEC: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dccf0 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFCEC: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dcd48 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFD62: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dd000 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFD62: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dd058 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFD62: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7905A: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dd698 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C790A0: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dd878 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C792AB: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63de568 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C792EC: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63de788 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA83: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E32C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x92D3580: orte_rmaps_resilient_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rmaps_resilient.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63f8b48 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x92D3580: orte_rmaps_resilient_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rmaps_resilient.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63f8b98 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x92D3580: orte_rmaps_resilient_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rmaps_resilient.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD2862: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CD286B: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CD2877: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CD2881: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CD28A2: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CD209F: look_sysfsnode (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBF03: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CD20AF: look_sysfsnode (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBF03: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD20AB: look_sysfsnode (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBF03: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E774: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8C9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8D8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E4: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD72A: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD73B: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD740: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD756: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD758: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CDB9A8: opal_hwloc132_hwloc_obj_add_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCD76D: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD72A: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD73B: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD740: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD756: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD758: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC1C8: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC1D9: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC1DE: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC1F4: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCC1F6: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC359: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC36A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC36F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC385: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCC387: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC67B: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC68C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC691: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC6A7: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCC6A9: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC80C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC81D: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC822: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC838: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCC83A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC99D: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC9AE: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC9B3: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC9C9: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCC9CB: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCB2E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCB3F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCB44: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCB5A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCCB5C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCE50: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCE61: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCE66: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCE7C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCCE7E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCFE1: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCFF2: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCFF7: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD00D: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD00F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD172: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD183: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD188: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD19E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD1A0: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD303: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD314: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD319: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD32F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD331: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD49E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD4AF: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD4B4: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD4CA: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD4CC: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x7765C25: query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_sysinfo_linux.so) > ==102997== by 0x4CF2782: opal_sysinfo_base_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C664D2: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6368e78 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C66542: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64ad018 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E3C0: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C665D1: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C47EDB: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331ab8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C0E357: ??? > ==102997== by 0x7FEFFEA8F: ??? > ==102997== by 0x7FEFFEAB7: ??? > ==102997== by 0x4C0DFFF: ??? (in /usr/lib64/valgrind/vgpreload_memcheck-amd64-linux.so) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48024: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b5e60 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C47FC9: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E9CB: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48024: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b5f60 is 0 bytes inside a block of size 2 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C47FE7: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48024: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6130 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB65CA: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA83: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA98: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EAB8: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB8D: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB92: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EB96: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C48146: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6130 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x736E6F6973736572: ??? > ==102997== by 0x31756F76616B732C: ??? > ==102997== by 0x323733656B696D3F: ??? > ==102997== by 0x305E: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5FE0: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b61b0 is 48 bytes inside a block of size 52 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5FE0: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6158: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6158: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB60EE: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CB60FB: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6114: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6114: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b63e0 is 32 bytes inside a block of size 35 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x736E6F6973736572: ??? > ==102997== by 0x31756F76616B732C: ??? > ==102997== by 0x323733656B696D3F: ??? > ==102997== by 0x305E: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB60FA: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6114: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E9FA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6494 is 4 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x736E6F6973736572: ??? > ==102997== by 0x31756F76616B732C: ??? > ==102997== by 0x323733656B696D3F: ??? > ==102997== by 0x305E: ??? > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E9CB: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6550 is 0 bytes inside a block of size 2 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x736E6F6973736572: ??? > ==102997== by 0x31756F76616B732C: ??? > ==102997== by 0x323733656B696D3F: ??? > ==102997== by 0x305E: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E985: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6690 is 48 bytes inside a block of size 50 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB5FEB: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C47C16: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6270 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x7563962: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331ab8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C0E357: ??? > ==102997== by 0x7FEFFEA8F: ??? > ==102997== by 0x7FEFFEAB7: ??? > ==102997== by 0x4C0DFFF: ??? (in /usr/lib64/valgrind/vgpreload_memcheck-amd64-linux.so) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E5BD: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4F9F90: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64caa30 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4F9F90: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64caa88 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4F9FC4: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cac60 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4F9FC4: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cacb8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cae90 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64caee0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb160 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb1b0 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA09B: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb440 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA09B: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb490 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA09B: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA0CB: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb720 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA0CB: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb778 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA11C: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb970 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA11C: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb9c8 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E693: orte_filem_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AB1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C45748: orte_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AE2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cd3b8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701A60: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d65d8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701A60: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d6620 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C48: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701A60: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701A94: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d6918 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701A94: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d6968 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701AC8: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d6b58 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701AC8: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d6ba8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65812: orte_notifier_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AFC: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA47: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFE39: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dd1f0 is 16 bytes inside a block of size 22 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x90CFE9A: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x90CFEAE: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x90CFEB7: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x90D0015: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x90D0021: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x90D0025: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x90D002E: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C52A7A: orte_util_encode_nodemap (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6CBD4: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b7fe8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C52AA6: orte_util_encode_nodemap (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6CBD4: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64ea868 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8751A: opal_dss_pack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C871E3: opal_dss_pack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C52B13: orte_util_encode_nodemap (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6CBD4: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64ea868 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C87536: opal_dss_pack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C871E3: opal_dss_pack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7C40C: orte_rml_base_get_contact_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B70485: get_wireup_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_binomial.so) > ==102997== by 0x4C6CCAC: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b8580 is 64 bytes inside a block of size 65 alloc'd > ==102997== at 0x4A06C20: realloc (vg_replace_malloc.c:662) > ==102997== by 0x3C8BA6F3D2: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x7969BD8: orte_rml_oob_get_uri (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x7563A05: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8751A: opal_dss_pack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C3FCA2: orte_dt_pack_app_context (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C871E3: opal_dss_pack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6D114: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61a0e38 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x2E36342E30392E33: ??? > ==102997== by 0x313436353A383130: ??? > ==102997== by 0x400031: ??? (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x86B5450: mca_oob_tcp_parse_uri (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x86B51DF: mca_oob_tcp_set_addr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x7969C83: orte_rml_oob_set_uri (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4C7C4EA: orte_rml_base_update_contact_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B705E5: init_routes (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_binomial.so) > ==102997== by 0x4C6C86F: orte_odls_base_default_update_daemon_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A912: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x64ed998 is 24 bytes inside a block of size 26 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB5A68: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x64f00a8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E757: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5AAB: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x64f00a8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5A84: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x64f17e0 is 16 bytes inside a block of size 20 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB5910: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== Address 0x61a39a8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x535300303030313C: ??? > ==102997== by 0x544E45494C435F47: ??? > ==102997== by 0x2E3532312E36393C: ??? > ==102997== by 0x332035392E323130: ??? > ==102997== by 0x32322038383232: ??? > ==102997== by 0x52415F435354454F: ??? > ==102997== by 0x5000656E6F3D4842: ??? > ==102997== by 0x414E424F4A5F5341: ??? > ==102997== by 0x6F73696E613D454C: ??? > ==102997== by 0x5952415242494BFF: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5967: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x61a39a8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x535300303030313C: ??? > ==102997== by 0x544E45494C435F47: ??? > ==102997== by 0x2E3532312E36393C: ??? > ==102997== by 0x332035392E323130: ??? > ==102997== by 0x32322038383232: ??? > ==102997== by 0x52415F435354454F: ??? > ==102997== by 0x5000656E6F3D4842: ??? > ==102997== by 0x414E424F4A5F5341: ??? > ==102997== by 0x6F73696E613D454C: ??? > ==102997== by 0x5952415242494BFF: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5AAB: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x64f2328 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E578: __intel_sse2_strchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5957: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x61a42a8 is 24 bytes inside a block of size 25 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4F5449525245545E: ??? > ==102997== by 0x53555F6E653D5951: ??? > ==102997== by 0x2F3D434E495450FF: ??? > ==102997== by 0x3662696C2F727374: ??? > ==102997== by 0x332E332D74712F33: ??? > ==102997== by 0x6564756C636E692E: ??? > ==102997== by 0x575F4F5F53424FFF: ??? > ==102997== by 0x2F3D5249444B524E: ??? > ==102997== by 0x616B732F656D6F67: ??? > ==102997== by 0x726F772F31756F75: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B08C: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B13A: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B13A: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA856E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D2BD: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB5A68: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D2E0: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x65111c8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D2E0: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5C36: opal_unsetenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D319: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x65116d8 is 0 bytes after a block of size 24 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5BFE: opal_unsetenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D319: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5C5A: opal_unsetenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D319: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x64f2328 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB5A68: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D98: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6512cc0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D98: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAC84F: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4A436: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x6512d20 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAC8A2: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4A436: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x6512d20 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C4A464: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== Address 0x6512d80 is 16 bytes inside a block of size 17 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C4A499: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== Address 0x64eeb00 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C89F6D: opal_dss_unpack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8A924: opal_dss_unpack_buffer (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C41DE4: orte_dt_unpack_app_context (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8A924: opal_dss_unpack_buffer (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C890B9: opal_dss_unpack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6C118: orte_odls_base_default_construct_child_list (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD1FD: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA47: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40C88C: orte_debugger_init_after_spawn (orterun.c:2904) > ==102997== by 0x405C4F: orterun (orterun.c:921) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61a3070 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA81021: strdup (in /lib64/libc-2.12.so) > ==102997== by 0x40A30F: create_app (orterun.c:2180) > ==102997== by 0x408ACD: parse_locals (orterun.c:1681) > ==102997== by 0x404D1E: orterun (orterun.c:658) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Too many processors in X direction: 2 1 > [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 > [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack > [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c > [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c > [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: -ksp_gmres_restart 300 > [0]PETSC ERROR: -ksp_type gmres > [0]PETSC ERROR: -log_view > [0]PETSC ERROR: -pc_asm_overlap 4 > [0]PETSC ERROR: -pc_type asm > [0]PETSC ERROR: -snes_atol 1.0e-20 > [0]PETSC ERROR: -snes_linesearch_type bt > [0]PETSC ERROR: -snes_mf > [0]PETSC ERROR: -snes_monitor > [0]PETSC ERROR: -snes_type newtontr > [0]PETSC ERROR: -sub_ksp_type preonly > [0]PETSC ERROR: -sub_pc_type lu > [0]PETSC ERROR: -ts_adapt_monitor > [0]PETSC ERROR: -ts_max_snes_failures -1 > [0]PETSC ERROR: -ts_monitor > [0]PETSC ERROR: -ts_type bdf > [0]PETSC ERROR: -ts_view > [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Too many processors in X direction: 2 1 > [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 > [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack > [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c > [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c > [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: -ksp_gmres_restart 300 > [0]PETSC ERROR: -ksp_type gmres > [0]PETSC ERROR: -log_view > [0]PETSC ERROR: -pc_asm_overlap 4 > [0]PETSC ERROR: -pc_type asm > [0]PETSC ERROR: -snes_atol 1.0e-20 > [0]PETSC ERROR: -snes_linesearch_type bt > [0]PETSC ERROR: -snes_mf > [0]PETSC ERROR: -snes_monitor > [0]PETSC ERROR: -snes_type newtontr > [0]PETSC ERROR: -sub_ksp_type preonly > [0]PETSC ERROR: -sub_pc_type lu > [0]PETSC ERROR: -ts_adapt_monitor > [0]PETSC ERROR: -ts_max_snes_failures -1 > [0]PETSC ERROR: -ts_monitor > [0]PETSC ERROR: -ts_type bdf > [0]PETSC ERROR: -ts_view > [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Too many processors in X direction: 2 1 > [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 > [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack > [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c > [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c > [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: -ksp_gmres_restart 300 > [0]PETSC ERROR: -ksp_type gmres > [0]PETSC ERROR: -log_view > [0]PETSC ERROR: -pc_asm_overlap 4 > [0]PETSC ERROR: -pc_type asm > [0]PETSC ERROR: -snes_atol 1.0e-20 > [0]PETSC ERROR: -snes_linesearch_type bt > [0]PETSC ERROR: -snes_mf > [0]PETSC ERROR: -snes_monitor > [0]PETSC ERROR: -snes_type newtontr > [0]PETSC ERROR: -sub_ksp_type preonly > [0]PETSC ERROR: -sub_pc_type lu > [0]PETSC ERROR: -ts_adapt_monitor > [0]PETSC ERROR: -ts_max_snes_failures -1 > [0]PETSC ERROR: -ts_monitor > [0]PETSC ERROR: -ts_type bdf > [0]PETSC ERROR: -ts_view > [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Too many processors in X direction: 2 1 > [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 > [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack > [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c > [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c > [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: -ksp_gmres_restart 300 > [0]PETSC ERROR: -ksp_type gmres > [0]PETSC ERROR: -log_view > [0]PETSC ERROR: -pc_asm_overlap 4 > [0]PETSC ERROR: -pc_type asm > [0]PETSC ERROR: -snes_atol 1.0e-20 > [0]PETSC ERROR: -snes_linesearch_type bt > [0]PETSC ERROR: -snes_mf > [0]PETSC ERROR: -snes_monitor > [0]PETSC ERROR: -snes_type newtontr > [0]PETSC ERROR: -sub_ksp_type preonly > [0]PETSC ERROR: -sub_pc_type lu > [0]PETSC ERROR: -ts_adapt_monitor > [0]PETSC ERROR: -ts_max_snes_failures -1 > [0]PETSC ERROR: -ts_monitor > [0]PETSC ERROR: -ts_type bdf > [0]PETSC ERROR: -ts_view > [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > [unset]: aborting job: > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > [unset]: aborting job: > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > [unset]: aborting job: > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > [unset]: aborting job: > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68E02: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b66e0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68E02: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6750 is 32 bytes inside a block of size 35 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C486B9: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b66e0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x653b270 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C486FB: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA83: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA98: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EAB8: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB8D: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB92: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EB96: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C487A3: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x653b170 is 0 bytes inside a block of size 2 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C46EBA: orte_util_convert_vpid_to_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C486CA: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C487E2: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9B4: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C487E2: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4844C: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b66e0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C484C2: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x654ea00 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C48476: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C484C2: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA2DE: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== Address 0x654f550 is 16 bytes inside a block of size 23 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA410: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== Address 0x654fd40 is 64 bytes inside a block of size 67 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA44F: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA44F: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== Address 0x654fd40 is 64 bytes inside a block of size 67 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA479: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA479: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA47: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== Address 0x654fe68 is 24 bytes inside a block of size 28 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA499: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA499: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > -------------------------------------------------------------------------- > mpiexec noticed that the job aborted, but has no info as to the process > that caused that situation. > -------------------------------------------------------------------------- > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C484EC: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4063E5: just_quit (orterun.c:1046) > ==102997== by 0x406302: job_completed (orterun.c:1016) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6550f20 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C48476: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4063E5: just_quit (orterun.c:1046) > ==102997== by 0x406302: job_completed (orterun.c:1016) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C484EC: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4063E5: just_quit (orterun.c:1046) > ==102997== by 0x406302: job_completed (orterun.c:1016) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB3: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4853B: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4063E5: just_quit (orterun.c:1046) > ==102997== by 0x406302: job_completed (orterun.c:1016) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA59: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4853B: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4063E5: just_quit (orterun.c:1046) > ==102997== by 0x406302: job_completed (orterun.c:1016) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== > ==102997== HEAP SUMMARY: > ==102997== in use at exit: 411,245 bytes in 3,053 blocks > ==102997== total heap usage: 8,975 allocs, 5,922 frees, 12,560,021 bytes allocated > ==102997== > ==102997== LEAK SUMMARY: > ==102997== definitely lost: 52,793 bytes in 43 blocks > ==102997== indirectly lost: 17,831 bytes in 61 blocks > ==102997== possibly lost: 0 bytes in 0 blocks > ==102997== still reachable: 340,621 bytes in 2,949 blocks > ==102997== suppressed: 0 bytes in 0 blocks > ==102997== Rerun with --leak-check=full to see details of leaked memory > ==102997== > ==102997== For counts of detected and suppressed errors, rerun with: -v > ==102997== Use --track-origins=yes to see where uninitialised values come from > ==102997== ERROR SUMMARY: 45427 errors from 796 contexts (suppressed: 6 from 6) From skavou1 at lsu.edu Wed Jul 19 10:56:53 2017 From: skavou1 at lsu.edu (Sepideh Kavousi) Date: Wed, 19 Jul 2017 15:56:53 +0000 Subject: [petsc-users] error in DMDACreate3d In-Reply-To: <0B565A8A-C344-42C2-8A02-910D1FB6F6C7@mcs.anl.gov> References: , <0B565A8A-C344-42C2-8A02-910D1FB6F6C7@mcs.anl.gov> Message-ID: The problem was solved when I gave the directory of mpiecex in petsc installed packages before writing mpiexec. Thanks, Sepideh ________________________________ From: Barry Smith Sent: Wednesday, July 19, 2017 10:32:16 AM To: Sepideh Kavousi Cc: petsc-users at mcs.anl.gov Subject: Re: [petsc-users] error in DMDACreate3d Sepideh, All of the valgrind messages are from OpenMPI (it is horribly not valgrind clean; you should use --download-mpich if you want to use MPI with valgrind). Please send the output from running on both systems without valgrind. I want to see the exact error message. Are you running with -pc_type mg ? Barry > On Jul 19, 2017, at 10:10 AM, Sepideh Kavousi wrote: > > Hi, > I am writing a petsc code where I create a 3d da object using DMDACreate3d, I want to have 2 processors in x , 1 processor in y and 2 processors in z direction. for this I write: > > ierr= DMDACreate3d(PETSC_COMM_WORLD,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DM_BOUNDARY_NONE,DMDA_STENCIL_BOX, > 60,60,60,2,1,2,2,1,llx,lly,llz,&da2) ;CHKERRQ(ierr); > and llx and lly and llz are as : llx[2]={30,30},lly[1]={60},llz[2]={30,30} > it works fine when I run with my personal workstation. But when I want to run it on hpc it gives an error. and by running with valgrind it gives the following error. I do not understand why it says: Too many processors in X direction: 2 1. Can some one please help me about it? > Thanks, > Sepideh > > > > ==102997== Memcheck, a memory error detector > ==102997== Copyright (C) 2002-2012, and GNU GPL'd, by Julian Seward et al. > ==102997== Using Valgrind-3.8.1 and LibVEX; rerun with -h for copyright info > ==102997== Command: mpiexec -n 4 ./try3-jacob-3.out -ts_monitor -snes_monitor -snes_mf -log_view -ts_max_snes_failures -1 -ts_type bdf -snes_type newtontr -pc_type asm -ksp_gmres_restart 300 -sub_ksp_type preonly -sub_pc_type lu -pc_asm_overlap 4 -ts_adapt_monitor -snes_linesearch_type bt -ksp_type gmres -snes_atol 1.0e-20 -snes_monitor -ts_view -ts_adapt_monitor > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAC833: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40446C: orterun (orterun.c:494) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61528f8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x742F2E0034006E2C: ??? > ==102997== by 0x6F63616A2D337971: ??? > ==102997== by 0x74756F2E332D61: ??? > ==102997== by 0x696E6F6D5F73742C: ??? > ==102997== by 0x656E732D00726F73: ??? > ==102997== by 0x6F74696E6F6D5F72: ??? > ==102997== by 0x5F73656E732D0071: ??? > ==102997== by 0x5F676F6C2D00666C: ??? > ==102997== by 0x73742D0077656975: ??? > ==102997== by 0x656E735F78616D5E: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAC886: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40446C: orterun (orterun.c:494) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61528f8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x742F2E0034006E2C: ??? > ==102997== by 0x6F63616A2D337971: ??? > ==102997== by 0x74756F2E332D61: ??? > ==102997== by 0x696E6F6D5F73742C: ??? > ==102997== by 0x656E732D00726F73: ??? > ==102997== by 0x6F74696E6F6D5F72: ??? > ==102997== by 0x5F73656E732D0071: ??? > ==102997== by 0x5F676F6C2D00666C: ??? > ==102997== by 0x73742D0077656975: ??? > ==102997== by 0x656E735F78616D5E: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACAED: opal_cmd_line_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044AA: orterun (orterun.c:498) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8683: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA868E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CACCB8: opal_cmd_line_make_opt_mca (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1045: mca_base_cmd_line_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044B9: orterun (orterun.c:499) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAD821: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044E1: orterun (orterun.c:500) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x615ce50 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F63616A2D337971: ??? > ==102997== by 0x74756F2E332D61: ??? > ==102997== by 0x696E6F6D5F73742C: ??? > ==102997== by 0x656E732D00726F73: ??? > ==102997== by 0x6F74696E6F6D5F72: ??? > ==102997== by 0x5F73656E732D0071: ??? > ==102997== by 0x5F676F6C2D00666C: ??? > ==102997== by 0x73742D0077656975: ??? > ==102997== by 0x656E735F78616D5E: ??? > ==102997== by 0x72756C6961665F72: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAD9D5: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044E1: orterun (orterun.c:500) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x615ce50 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F63616A2D337971: ??? > ==102997== by 0x74756F2E332D61: ??? > ==102997== by 0x696E6F6D5F73742C: ??? > ==102997== by 0x656E732D00726F73: ??? > ==102997== by 0x6F74696E6F6D5F72: ??? > ==102997== by 0x5F73656E732D0071: ??? > ==102997== by 0x5F676F6C2D00666C: ??? > ==102997== by 0x73742D0077656975: ??? > ==102997== by 0x656E735F78616D5E: ??? > ==102997== by 0x72756C6961665F72: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CABAF8: opal_argv_append_nosize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CABB75: opal_argv_append (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAD38B: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044E1: orterun (orterun.c:500) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x615cf00 is 0 bytes inside a block of size 2 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x332D626F63616A2C: ??? > ==102997== by 0x73742D0074756F2D: ??? > ==102997== by 0x726F74696E6F6D5E: ??? > ==102997== by 0x6D5F73656E732CFF: ??? > ==102997== by 0x2D00726F74696E6E: ??? > ==102997== by 0x666D5F73656E72: ??? > ==102997== by 0x6569765F676F6C2C: ??? > ==102997== by 0x616D5F73742D0076: ??? > ==102997== by 0x665F73656E735F77: ??? > ==102997== by 0x736572756C6960: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EF46: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== Address 0x615cfd0 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E332D626F6360: ??? > ==102997== by 0x6D5F73742D007474: ??? > ==102997== by 0x2D00726F74696E6E: ??? > ==102997== by 0x6E6F6D5F73656E72: ??? > ==102997== by 0x6E732D00726F7468: ??? > ==102997== by 0x6C2D00666D5F7364: ??? > ==102997== by 0x776569765F676E: ??? > ==102997== by 0x5F78616D5F73742C: ??? > ==102997== by 0x6961665F73656E72: ??? > ==102997== by 0x312D00736572756B: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CABAF8: opal_argv_append_nosize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CABB75: opal_argv_append (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAD600: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4044E1: orterun (orterun.c:500) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x615d098 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x656E732D00726F73: ??? > ==102997== by 0x6F74696E6F6D5F72: ??? > ==102997== by 0x5F73656E732D0071: ??? > ==102997== by 0x5F676F6C2D00666C: ??? > ==102997== by 0x73742D0077656975: ??? > ==102997== by 0x656E735F78616D5E: ??? > ==102997== by 0x72756C6961665F72: ??? > ==102997== by 0x742D00312D007364: ??? > ==102997== by 0x6200657079745F72: ??? > ==102997== by 0x73656E732D006663: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB698C: opal_output_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9023: opal_output_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84BBD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6161a80 is 16 bytes inside a block of size 18 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB8E9E: opal_output_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84BBD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6164d48 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA54A: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAACDD: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61650b0 is 16 bytes inside a block of size 23 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA6F6A3: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA756C4: _IO_str_init_static_internal (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F703: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7455B: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7456F: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74578: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74582: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74670: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA745E5: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA48160: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0A02A: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0A033: mempcpy (mc_replace_strmem.c:128) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0A048: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0A095: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A0A0A8: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A0A0AC: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0A0BB: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A0A0BB: mempcpy (mc_replace_strmem.c:1268) > ==102997== by 0x3C8BA7461D: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x3C8BA6F71E: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA575: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAACDD: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61656f0 is 16 bytes inside a block of size 21 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA6F6A3: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x3C8BA6F71E: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA5D4: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAACDD: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6165ce8 is 24 bytes inside a block of size 27 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD56: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD63: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA6F6A3: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x3C8BA6F71E: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA601: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08B6A: memcpy (mc_replace_strmem.c:119) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08B8C: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08C18: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08C3E: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08C5B: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08C6C: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08C80: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08C8C: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08C98: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08CB2: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08CB8: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08CBF: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08CCA: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F2E2F31756F7660: ??? > ==102997== by 0x6D2F69706D6E656F: ??? > ==102997== by 0x6D617261702D6162: ??? > ==102997== by 0x666E6F632E72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB510C: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB511A: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A06BAE: realloc (vg_replace_malloc.c:662) > ==102997== by 0x4CB5137: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB5164: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB517C: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E3B5: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E410: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== > ==102997== More than 100 errors detected. Subsequent errors > ==102997== will still be recorded, but in less detail than before. > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E41D: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E4EC: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E502: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5187: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB518B: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAB8E9: save_value (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB52E6: opal_util_keyval_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAA8EF: mca_base_param_recache_files (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB796: mca_base_param_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAB0F2: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D03: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D09: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08D21: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08D28: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D2A: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D13: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D30: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D76: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD3B: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB561D: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CABAF8: opal_argv_append_nosize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CABB75: opal_argv_append (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CABD1F: opal_argv_split (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB5630: opal_net_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C6D: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617be00 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x3C8BA74667: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAE55: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84F9A: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617bb58 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C84F41: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617c038 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55D0: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55D0: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55DD: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55DD: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84FD7: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85027: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617c238 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7458C: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4814F: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CAAE40: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85027: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF201F: opal_shmem_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8503E: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617c418 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA560D: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF201F: opal_shmem_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8503E: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF8F8: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617d198 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA7356: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA7356: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA7370: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA7370: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA737C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA737C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA73A8: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF96C: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF9B7: opal_paffinity_base_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8504C: opal_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84C99: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617d9d8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA844D: mca_base_param_lookup_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBCC96: opal_util_register_stackhandlers (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CB2: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617bf28 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA82F4: mca_base_param_lookup_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBCC96: opal_util_register_stackhandlers (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CB2: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617dd18 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5557: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBD0B0: opal_util_init_sys_limits (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CCB: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617de60 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA621A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617e070 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617e0c0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62C7: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62C7: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62E2: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62E2: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA630A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA630A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6317: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6317: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AAFC: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA621A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617e238 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617e280 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA630A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6317: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6347: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB37: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6236: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB67: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617f550 is 16 bytes inside a block of size 17 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8AB67: opal_dss_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84CFD: opal_init_util (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40458C: orterun (orterun.c:535) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x617f5a0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42E29: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6180ff8 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAAD93: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42E29: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6181058 is 24 bytes inside a block of size 31 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CAACE8: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42E29: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42E7C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6181408 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42EBD: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61815f0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42EBD: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42F08: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61817e8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C42F2E: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61819d8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4315F: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6184ff8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C431A0: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61851f8 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA560D: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C431A0: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6185258 is 24 bytes inside a block of size 31 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CA5562: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C431A0: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C431EB: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61853e8 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43245: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6185818 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43298: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6185c30 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43298: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C432D9: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6185e18 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43339: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6186028 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C433E1: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6186508 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43432: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6186728 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43511: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6186de8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43511: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA7356: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43530: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C435AA: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61874a8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C435EB: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6187688 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43643: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6187878 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43689: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6187a68 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43689: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C437A6: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61882d8 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C437F2: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61884d8 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8E12: param_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAAF43: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C437F2: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61885f0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA8CCF: param_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CAAF43: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C437F2: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6188640 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43860: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61889b0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43860: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C438EE: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6188e18 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C438EE: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA739C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43910: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA739C: mca_base_param_reg_syn_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4392B: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43A3C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6189c78 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43A3C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43A6C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6189e48 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43A6C: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43A95: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x618e478 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43AD1: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x618e648 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43B0D: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x618e818 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43B0D: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43D03: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x618edf8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C43D4B: orte_register_params (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404BB9: orterun (orterun.c:632) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x618efd8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAD9D5: opal_cmd_line_parse (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4092E9: create_app (orterun.c:1908) > ==102997== by 0x408ACD: parse_locals (orterun.c:1681) > ==102997== by 0x404D1E: orterun (orterun.c:658) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x619c0f0 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4826: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61ae808 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4871: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA48C5: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af098 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA48C5: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA48FA: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af200 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4933: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af250 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4982: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af250 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6C67: opal_output_reopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C03: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af360 is 16 bytes inside a block of size 18 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA4BF7: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8EB45: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F942: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af548 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8B6C2: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F92A: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8FAA6: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af598 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F942: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8FBE5: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af598 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F942: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C9172F: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af5e0 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C9179A: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af5e0 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8B67F: lt__strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af638 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9175B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8B68F: lt__strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0937A: _intel_fast_memcpy (mc_replace_strmem.c:119) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0939C: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09513: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09519: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09531: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09538: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0953A: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09540: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A0955C: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09563: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09566: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09586: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8B6D5: lt__memdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F6D5: tryall_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C917FA: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C92C11: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af5e0 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E2D8: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92DD2: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af5e4 is 4 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E2E4: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92DD2: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af5e4 is 4 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8FC7B: try_dlopen..0 (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C313: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9353B: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D22: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D22: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93190: loader_init_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C93552: lt_dlpreload_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9313F: lt_dlinit (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3BB4: mca_base_component_repository_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4C27: mca_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849A7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFAB7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61af968 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA43F0: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3E4A: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b09d8 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8E79B: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0cc8 is 56 bytes inside a block of size 59 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA8AEE2: argz_create_sep (in /lib64/libc-2.12.so) > ==102997== by 0x4C8E710: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E31C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8E809: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0cc8 is 56 bytes inside a block of size 59 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA8AEE2: argz_create_sep (in /lib64/libc-2.12.so) > ==102997== by 0x4C8E710: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C919D5: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0d48 is 56 bytes inside a block of size 60 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E7D1: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C919D5: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4C919D6: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91A66: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0d48 is 56 bytes inside a block of size 60 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E7D1: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91A66: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E31C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0d48 is 56 bytes inside a block of size 60 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E7D1: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E32C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E33C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E345: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E35C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E373: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E38C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91B9B: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91BAA: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91BAA: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EC15: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91BB8: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC37: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91BB8: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91BB8: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4C91BB9: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91E19: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b8e48 is 72 bytes inside a block of size 73 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91B6C: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E5B8: __intel_sse2_strend (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91C66: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61bbcd0 is 1,088 bytes inside a block of size 1,091 alloc'd > ==102997== at 0x4A06C20: realloc (vg_replace_malloc.c:662) > ==102997== by 0x3C8BA8B16F: argz_insert (in /lib64/libc-2.12.so) > ==102997== by 0x4C91C9D: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E5B8: __intel_sse2_strend (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C91D8D: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6201eb8 is 6,312 bytes inside a block of size 6,314 alloc'd > ==102997== at 0x4A06C20: realloc (vg_replace_malloc.c:662) > ==102997== by 0x3C8BA8B16F: argz_insert (in /lib64/libc-2.12.so) > ==102997== by 0x4C91C9D: foreachfile_callback (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8E85C: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E5B8: __intel_sse2_strend (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8E8A7: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0cc8 is 56 bytes inside a block of size 59 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA8AEE2: argz_create_sep (in /lib64/libc-2.12.so) > ==102997== by 0x4C8E710: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E578: __intel_sse2_strchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA1DC4: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0bc8 is 88 bytes inside a block of size 93 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8E6A2: foreach_dirinpath (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C91EF6: lt_dlforeachfile (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1EF1: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61b0bc8 is 88 bytes inside a block of size 93 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA17BE: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA189F: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6202798 is 72 bytes inside a block of size 76 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E5DA: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E601: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E677: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA621A: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x620e438 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA624D: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x620e488 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62C7: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBFCC7: opal_hwloc_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849BD: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E6C8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6207c18 is 72 bytes inside a block of size 79 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E774: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8C1: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8C9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8D8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA1988: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CA198A: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E3C0: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6207c1c is 76 bytes inside a block of size 79 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E3C8: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6207c1c is 76 bytes inside a block of size 79 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E449: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19F5: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6207c18 is 72 bytes inside a block of size 79 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E477: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA1A4C: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6207c18 is 72 bytes inside a block of size 79 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E4: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA18BA: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EB61: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C693: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x62116a0 is 80 bytes inside a block of size 82 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C660: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8C833: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6211740 is 80 bytes inside a block of size 82 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C693: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8C973: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6211740 is 80 bytes inside a block of size 82 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8EB6C: canonicalize_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C693: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8D5C6: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6212438 is 56 bytes inside a block of size 59 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F50B: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8D633: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6212340 is 16 bytes inside a block of size 23 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F5BD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8B69B: lt__strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D702: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6212570 is 80 bytes inside a block of size 82 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D645: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA27FB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92BAA: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92C2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6211820 is 16 bytes inside a block of size 20 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C9CA: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C92C41: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E2FA: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92DD2: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6211820 is 16 bytes inside a block of size 20 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C9CA: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D22: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA59: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA98: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EAB8: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB8D: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB92: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EB96: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E30A: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E33C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E345: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E35C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E373: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E38C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6213710 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6213768 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FB7: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FB7: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FD2: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FD2: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5007: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5007: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5037: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6552EB1: hwloc_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_paffinity_hwloc.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF88B: opal_paffinity_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C849F9: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6214b60 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4F59: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6214bc0 is 16 bytes inside a block of size 20 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FFA: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FFA: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5007: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5037: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6214c38 is 40 bytes inside a block of size 46 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CA4F64: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF3F4: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF41D: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6214de0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF449: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x62150e0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF475: linux_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x62153e0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEBAC2: opal_memory_linux_hook_pull (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF5E7: opal_memory_linux_ptmalloc2_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF4D6: linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6215710 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEBAC2: opal_memory_linux_hook_pull (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF5E7: opal_memory_linux_ptmalloc2_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CEF4D6: linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE6536: opal_memory_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A32: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6215768 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE62C9: opal_memchecker_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A61: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6315bd8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55DD: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CE62C9: opal_memchecker_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84A61: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E774: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8C9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8D8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E4: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CF2AF8: opal_timer_linux_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF2A60: opal_timer_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AAC: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDE5F: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6317f38 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E449: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6203110 is 80 bytes inside a block of size 81 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E477: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19F5: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6203110 is 80 bytes inside a block of size 81 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7455B: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7456F: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74578: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74582: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74670: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA745E5: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA440E8: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA440F3: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7455B: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA7456F: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74578: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74582: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x3C8BA74667: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA74670: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA745E5: _IO_default_xsputn (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA445DE: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x3C8BA445F0: vfprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA6F711: vsnprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F1E2: snprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CA2871: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E924: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EEA1: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E93F: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EEA1: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EEDB: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8EF1B: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8EF24: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8EF2E: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0937A: _intel_fast_memcpy (mc_replace_strmem.c:119) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0939C: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09513: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09595: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A095FC: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A095FF: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09601: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F4DA: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4C8F4EB: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E924: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EFBD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E93F: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EFBD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C8EFF7: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8F031: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8F03A: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4C8F044: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0937A: _intel_fast_memcpy (mc_replace_strmem.c:119) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0939C: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09513: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09519: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09531: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09538: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A0953A: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09523: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09540: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A0955C: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A09563: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09566: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A09586: _intel_fast_memcpy (mc_replace_strmem.c:893) > ==102997== by 0x4C8F536: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4C8F544: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C92C11: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x631f078 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C9CA: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6F58B51: auto_detect_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_auto_detect.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6320d18 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6F58B51: auto_detect_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_auto_detect.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6320d68 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FFA: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x6F58B51: auto_detect_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_auto_detect.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6320fd0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6321020 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EBFB: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C05: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EC89: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C05: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C20: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C20: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C48: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C48: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DB35: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DBA9: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6321200 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715DBA9: file_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_carto_file.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CBDEBA: opal_carto_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AC5: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6321258 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9F0E2: opal_event_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84AF7: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6321908 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B212: mmap_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f120 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B280: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f380 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B280: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f3d8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2A9: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f700 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f990 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5BA2: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632f9f0 is 16 bytes inside a block of size 22 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C85: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632fa68 is 40 bytes inside a block of size 46 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CA5BAE: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C85: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x715B2D6: mmap_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_mmap.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x735DFDC: posix_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_posix.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632fd00 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x735DFDC: posix_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_posix.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632fd58 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7560CAC: sysv_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_sysv.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x632ffb0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7560CAC: sysv_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_shmem_sysv.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CF20B4: opal_shmem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B2E: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6330008 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85CB1: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6330308 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85D36: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63304e8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EEB2: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA55B5: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85D36: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85D36: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85D98: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63306c8 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85E6D: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6330d28 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85ED7: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6330f30 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85ED7: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85F2C: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331158 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C85FBF: opal_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C84B60: opal_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C39500: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331358 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C475E9: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63315c8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C475E9: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C476C2: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331998 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C476C2: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C476FD: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47739: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331bb8 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5601: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47739: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4777C: orte_proc_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395E3: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331d98 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E424: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x620466c is 76 bytes inside a block of size 77 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E42C: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x620466c is 76 bytes inside a block of size 77 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8D617: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x634c6d8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C8B635: lt__malloc (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8F5BD: parse_dotla_file (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8D258: try_dlopen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8C3BE: lt_dlopenadvise (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA27CB: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA6347: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x635bf28 is 24 bytes inside a block of size 30 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CA6274: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA62EF: mca_base_param_register_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA435F: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D15B: orte_ess_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C395FC: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637cbb0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637cc08 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FB7: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969B7B: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969BC3: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637cdf0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969BC3: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637ce48 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969C04: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d040 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969C04: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d098 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969C45: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d290 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969C45: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d2e8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969C86: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d4f0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969CC7: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d740 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D12: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d9a0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D12: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637d9f8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D3E: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637dc60 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D3E: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637dcb0 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D3E: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D60: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637de90 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969D60: orte_plm_rsh_component_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637dee8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637e120 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637e170 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40ECF9: __intel_sse2_strncat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C05: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B71001: plm_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74DB2: plm_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637e640 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA4FDF: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74DB2: plm_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6EFF7: orte_plm_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563471: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C74769: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637ea40 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C747C8: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637ea40 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x6F76616B732F6B71: ??? > ==102997== by 0x74706164612F3174: ??? > ==102997== by 0x796C754A2F657668: ??? > ==102997== by 0x6D756E2D656E6F2E: ??? > ==102997== by 0x366E6F6974616562: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB65CA: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x637ec68 is 56 bytes inside a block of size 62 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x69706D6F632F6C60: ??? > ==102997== by 0x746E492F7372656B: ??? > ==102997== by 0x6F706D6F632F6C64: ??? > ==102997== by 0x325F65785F726572: ??? > ==102997== by 0x37302E302E33312F: ??? > ==102997== by 0x6E692F6E69622F38: ??? > ==102997== by 0x752F0034366C6573: ??? > ==102997== by 0x6C61636F6C2F7272: ??? > ==102997== by 0x6567616B6361702E: ??? > ==102997== by 0x706D6E65706F2F72: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x637eb90 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x637ec68 is 56 bytes inside a block of size 62 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x69706D6F632F6C60: ??? > ==102997== by 0x746E492F7372656B: ??? > ==102997== by 0x6F706D6F632F6C64: ??? > ==102997== by 0x325F65785F726572: ??? > ==102997== by 0x37302E302E33312F: ??? > ==102997== by 0x6E692F6E69622F38: ??? > ==102997== by 0x752F0034366C6573: ??? > ==102997== by 0x6C61636F6C2F7272: ??? > ==102997== by 0x6567616B6361702E: ??? > ==102997== by 0x706D6E65706F2F72: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E985: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x6380418 is 56 bytes inside a block of size 57 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E985: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x6380418 is 56 bytes inside a block of size 57 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E963: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x63804e8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E9FA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x637eee4 is 4 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x732F3A6E69622F71: ??? > ==102997== by 0x7273752F3A6E6961: ??? > ==102997== by 0x752F3A6E6962732E: ??? > ==102997== by 0x6C61636F6C2F7272: ??? > ==102997== by 0x73752F3A6E69622E: ??? > ==102997== by 0x2F6C61636F6C2F71: ??? > ==102997== by 0x73752F3A6E696272: ??? > ==102997== by 0x2F36523131582F71: ??? > ==102997== by 0x7273752F3A6E6961: ??? > ==102997== by 0x702F6C61636F6C2E: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E963: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x63804e8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6788: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E963: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== Address 0x63804e8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74811: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7969FAF: orte_plm_rsh_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_rsh.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F2CE: orte_plm_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563480: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BB7C: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6380658 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BB7C: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2ED2: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6389c50 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2ED2: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6389ca8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2EFF: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6389ea0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2EFF: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6389ef8 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F2C: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a0f0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F2C: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a148 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F56: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a340 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F56: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a390 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F56: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F83: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a570 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F83: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a5c0 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2F83: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FB0: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a7a0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FB0: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a7f0 is 0 bytes inside a block of size 7 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FB0: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FDA: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638a9d0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FDA: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638aa28 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B2FDA: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3004: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638ac00 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3004: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638ac58 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B306D: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638ae40 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B306D: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638ae98 is 8 bytes inside a block of size 11 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3092: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b070 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3092: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b0c8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B30FE: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b2b0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B30FE: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b308 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3129: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b510 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3129: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b568 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B31FD: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638b830 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3227: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638bad0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B329F: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638bd30 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B329F: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638bd88 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3372: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638bf90 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B3372: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638bfe8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B342A: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638c1c0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B342A: mca_oob_tcp_component_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6E5E4: mca_oob_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7968B66: rml_oob_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BBAF: orte_rml_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634A3: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638c218 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BC46: orte_rml_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634B2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x638ca08 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7BC46: orte_rml_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634B2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E3D4: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB2A3B: opal_ifindextoname (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x86B66BB: mca_oob_tcp_component_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x4C6E857: mca_oob_base_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x79698F1: rml_oob_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4C7BCC4: orte_rml_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634B2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8ED0B06: orte_routed_radix_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_radix.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7C9A4: orte_routed_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634D0: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63b2530 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA502B: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8ED0B06: orte_routed_radix_component_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_radix.so) > ==102997== by 0x4CA45F7: mca_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7C9A4: orte_routed_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75634D0: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C749A0: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63c7cb0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C7487A: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C749FE: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63c7cb0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C7487A: orte_plm_base_rsh_launch_agent_lookup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB65BE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6722: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6722: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB3: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E9FA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63c97ac is 12 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74A48: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA17: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74ACF: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAC821: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63c97a8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB9673: opal_path_access (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB95C5: opal_path_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB933D: opal_path_findv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74A48: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAC821: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08D4C: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4A08D53: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4A08D56: memcpy (mc_replace_strmem.c:882) > ==102997== by 0x40EFCD: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAC833: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63cae38 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAC886: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63cae38 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAC8E8: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C74AFC: orte_plm_base_rsh_launch_agent_setup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D757DF: plm_tm_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x7563501: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63cae38 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCAC01: orte_ras_loadleveler_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_loadleveler.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dc798 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCAC01: orte_ras_loadleveler_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_loadleveler.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dc7e8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8ECCED1: ras_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dca50 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8ECCED1: ras_slurm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_slurm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dcaa8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFCEC: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dccf0 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFCEC: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dcd48 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFD62: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dd000 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFD62: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dd058 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C2D: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFD62: ras_tm_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C77D96: orte_ras_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563510: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7905A: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dd698 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C790A0: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dd878 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C792AB: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63de568 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CAACC1: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C792EC: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63de788 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA83: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D2D: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E32C: __intel_sse2_strcpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C92D96: lt_dlsym (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA2901: open_component (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA1D20: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x92D3580: orte_rmaps_resilient_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rmaps_resilient.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63f8b48 is 8 bytes inside a block of size 10 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x92D3580: orte_rmaps_resilient_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rmaps_resilient.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63f8b98 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x92D3580: orte_rmaps_resilient_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rmaps_resilient.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C79466: orte_rmaps_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x756352E: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD2862: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CD286B: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CD2877: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CD2881: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CD28A2: hwloc_find_linux_cpuset_mntpnt (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCA5B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CD209F: look_sysfsnode (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBF03: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CD20AF: look_sysfsnode (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBF03: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD20AB: look_sysfsnode (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBF03: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E774: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8C9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E8D8: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E4: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E8E9: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CD105B: look_sysfscpu (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCBE1E: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD72A: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD73B: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD740: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD756: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD758: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CDB9A8: opal_hwloc132_hwloc_obj_add_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCD76D: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC03F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD72A: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD73B: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD740: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD756: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD758: hwloc__get_dmi_one_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCC08A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC1C8: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC1D9: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC1DE: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC1F4: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCC1F6: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC359: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC36A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC36F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC385: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCC387: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC67B: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC68C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC691: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC6A7: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCC6A9: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC80C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC81D: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC822: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC838: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCC83A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC99D: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC9AE: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC9B3: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCC9C9: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCC9CB: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCB2E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCB3F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCB44: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCB5A: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCCB5C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCE50: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCE61: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCE66: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCE7C: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCCE7E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCFE1: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCFF2: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCCFF7: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD00D: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD00F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD172: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD183: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD188: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD19E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD1A0: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD303: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD314: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD319: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD32F: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD331: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD49E: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD4AF: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD4B4: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CCD4CA: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CCD4CC: hwloc__get_dmi_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CCB3B1: opal_hwloc132_hwloc_look_linux (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDD5A2: hwloc_discover (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CDCFAA: opal_hwloc132_hwloc_topology_load (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C668D0: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x7765C25: query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_sysinfo_linux.so) > ==102997== by 0x4CF2782: opal_sysinfo_base_query (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C664D2: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6368e78 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C66542: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64ad018 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E3C0: __intel_sse2_strncpy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA19A6: mca_base_component_find (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CA3F46: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C665D1: orte_odls_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563626: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C47EDB: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331ab8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C0E357: ??? > ==102997== by 0x7FEFFEA8F: ??? > ==102997== by 0x7FEFFEAB7: ??? > ==102997== by 0x4C0DFFF: ??? (in /usr/lib64/valgrind/vgpreload_memcheck-amd64-linux.so) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48024: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b5e60 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C47FC9: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E9CB: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48024: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b5f60 is 0 bytes inside a block of size 2 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C47FE7: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48024: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6130 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB65CA: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA83: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA98: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EAB8: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB8D: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB92: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EB96: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C48146: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6130 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x736E6F6973736572: ??? > ==102997== by 0x31756F76616B732C: ??? > ==102997== by 0x323733656B696D3F: ??? > ==102997== by 0x305E: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5FE0: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b61b0 is 48 bytes inside a block of size 52 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB6689: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48117: orte_session_dir_get_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47B35: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5FE0: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6158: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6158: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB60EE: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x4CB60FB: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6114: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6114: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b63e0 is 32 bytes inside a block of size 35 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x736E6F6973736572: ??? > ==102997== by 0x31756F76616B732C: ??? > ==102997== by 0x323733656B696D3F: ??? > ==102997== by 0x305E: ??? > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB60FA: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6114: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E9FA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6494 is 4 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x736E6F6973736572: ??? > ==102997== by 0x31756F76616B732C: ??? > ==102997== by 0x323733656B696D3F: ??? > ==102997== by 0x305E: ??? > ==102997== > ==102997== Invalid read of size 4 > ==102997== at 0x40E9CB: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6550 is 0 bytes inside a block of size 2 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x736E6F6973736572: ??? > ==102997== by 0x31756F76616B732C: ??? > ==102997== by 0x323733656B696D3F: ??? > ==102997== by 0x305E: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E985: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6034: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6690 is 48 bytes inside a block of size 50 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4CB5FEB: opal_os_dirpath_create (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C47E09: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C47C16: orte_session_dir (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x75636ED: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6270 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x7563962: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6331ab8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C0E357: ??? > ==102997== by 0x7FEFFEA8F: ??? > ==102997== by 0x7FEFFEAB7: ??? > ==102997== by 0x4C0DFFF: ??? (in /usr/lib64/valgrind/vgpreload_memcheck-amd64-linux.so) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E5BD: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4F9F90: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64caa30 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4F9F90: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64caa88 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4F9FC4: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cac60 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4F9FC4: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cacb8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cae90 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64caee0 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA045: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb160 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb1b0 is 0 bytes inside a block of size 3 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB9: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C55: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA06E: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA09B: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb440 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA09B: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb490 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CA5C79: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA09B: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA0CB: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb720 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA0CB: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb778 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA11C: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb970 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA4FA11C: filem_rsh_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_filem_rsh.so) > ==102997== by 0x4CA4094: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E600: orte_filem_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AA2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cb9c8 is 8 bytes inside a block of size 13 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5E693: orte_filem_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AB1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA553B: mca_base_param_reg_int_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C45748: orte_cr_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AE2: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64cd3b8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B53: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701A60: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d65d8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA5B86: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701A60: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d6620 is 0 bytes inside a block of size 4 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA5C48: mca_base_param_reg_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701A60: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701A94: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d6918 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701A94: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d6968 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F0A: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701AC8: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d6b58 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CA4F3D: mca_base_param_reg_int (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0xA701AC8: command_register (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_notifier_command.so) > ==102997== by 0x4CA4022: mca_base_components_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65A7E: orte_notifier_base_open (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AF1: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64d6ba8 is 8 bytes inside a block of size 9 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CAAD87: mca_base_param_reg_string_name (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C65812: orte_notifier_base_select (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7563AFC: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA47: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x90CFE39: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x63dd1f0 is 16 bytes inside a block of size 22 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x90CFE9A: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x90CFEAE: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x90CFEB7: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x90D0015: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E556: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x90D0021: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x90D0025: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x90D002E: allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ras_tm.so) > ==102997== by 0x4C77EDB: orte_ras_base_allocate (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C703F8: orte_plm_base_setup_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D74F60: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C52A7A: orte_util_encode_nodemap (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6CBD4: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b7fe8 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C52AA6: orte_util_encode_nodemap (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6CBD4: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64ea868 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8751A: opal_dss_pack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C871E3: opal_dss_pack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C52B13: orte_util_encode_nodemap (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6CBD4: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64ea868 is 0 bytes after a block of size 8 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C87536: opal_dss_pack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C871E3: opal_dss_pack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7C40C: orte_rml_base_get_contact_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B70485: get_wireup_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_binomial.so) > ==102997== by 0x4C6CCAC: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b8580 is 64 bytes inside a block of size 65 alloc'd > ==102997== at 0x4A06C20: realloc (vg_replace_malloc.c:662) > ==102997== by 0x3C8BA6F3D2: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x7969BD8: orte_rml_oob_get_uri (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x7563A05: rte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_ess_hnp.so) > ==102997== by 0x4C3961A: orte_init (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x404DBC: orterun (orterun.c:693) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4C8751A: opal_dss_pack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C3FCA2: orte_dt_pack_app_context (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C871E3: opal_dss_pack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6D114: orte_odls_base_default_get_add_procs_data (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7069F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61a0e38 is 8 bytes inside a block of size 12 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF55: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x2E36342E30392E33: ??? > ==102997== by 0x313436353A383130: ??? > ==102997== by 0x400031: ??? (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E90C: __intel_sse2_strrchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x86B5450: mca_oob_tcp_parse_uri (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x86B51DF: mca_oob_tcp_set_addr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_oob_tcp.so) > ==102997== by 0x7969C83: orte_rml_oob_set_uri (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_rml_oob.so) > ==102997== by 0x4C7C4EA: orte_rml_base_update_contact_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7B705E5: init_routes (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_routed_binomial.so) > ==102997== by 0x4C6C86F: orte_odls_base_default_update_daemon_info (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A912: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x64ed998 is 24 bytes inside a block of size 26 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB5A68: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x64f00a8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E757: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5AAB: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x64f00a8 is 8 bytes inside a block of size 15 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5A84: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x64f17e0 is 16 bytes inside a block of size 20 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB5910: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== Address 0x61a39a8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x535300303030313C: ??? > ==102997== by 0x544E45494C435F47: ??? > ==102997== by 0x2E3532312E36393C: ??? > ==102997== by 0x332035392E323130: ??? > ==102997== by 0x32322038383232: ??? > ==102997== by 0x52415F435354454F: ??? > ==102997== by 0x5000656E6F3D4842: ??? > ==102997== by 0x414E424F4A5F5341: ??? > ==102997== by 0x6F73696E613D454C: ??? > ==102997== by 0x5952415242494BFF: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EEF8: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5967: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x61a39a8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x535300303030313C: ??? > ==102997== by 0x544E45494C435F47: ??? > ==102997== by 0x2E3532312E36393C: ??? > ==102997== by 0x332035392E323130: ??? > ==102997== by 0x32322038383232: ??? > ==102997== by 0x52415F435354454F: ??? > ==102997== by 0x5000656E6F3D4842: ??? > ==102997== by 0x414E424F4A5F5341: ??? > ==102997== by 0x6F73696E613D454C: ??? > ==102997== by 0x5952415242494BFF: ??? > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5AAB: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB598B: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x64f2328 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E578: __intel_sse2_strchr (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5957: opal_environ_merge (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6AF83: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x61a42a8 is 24 bytes inside a block of size 25 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4F5449525245545E: ??? > ==102997== by 0x53555F6E653D5951: ??? > ==102997== by 0x2F3D434E495450FF: ??? > ==102997== by 0x3662696C2F727374: ??? > ==102997== by 0x332E332D74712F33: ??? > ==102997== by 0x6564756C636E692E: ??? > ==102997== by 0x575F4F5F53424FFF: ??? > ==102997== by 0x2F3D5249444B524E: ??? > ==102997== by 0x616B732F656D6F67: ??? > ==102997== by 0x726F772F31756F75: ??? > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EA41: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B08C: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86A2: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B13A: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA86AD: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B13A: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EF3C: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CA856E: mca_base_param_environ_variable (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D2BD: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB5A68: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D2E0: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x65111c8 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D2E0: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5C36: opal_unsetenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D319: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x65116d8 is 0 bytes after a block of size 24 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5BFE: opal_unsetenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D319: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E75B: __intel_sse2_strncmp (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB5C5A: opal_unsetenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5D319: orte_ess_env_put (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6B33E: odls_base_default_setup_fork (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D57: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== Address 0x64f2328 is 8 bytes inside a block of size 14 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB5A68: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D98: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6512cc0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4CB5A4C: opal_setenv (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69D98: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAC84F: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4A436: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x6512d20 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CAC8A2: opal_basename (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4A436: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== Address 0x6512d20 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C4A464: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== Address 0x6512d80 is 16 bytes inside a block of size 17 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4C4A499: orte_util_check_context_app (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C69EAA: orte_odls_base_default_launch_local (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD21A: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C70ABE: orte_plm_base_report_launched (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C7072F: orte_plm_base_launch_apps (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x7D7550D: plm_tm_launch_job (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_plm_tm.so) > ==102997== by 0x405C2E: orterun (orterun.c:917) > ==102997== Address 0x64eeb00 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x4C89F6D: opal_dss_unpack_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8A924: opal_dss_unpack_buffer (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C41DE4: orte_dt_unpack_app_context (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C8A924: opal_dss_unpack_buffer (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C890B9: opal_dss_unpack (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6C118: orte_odls_base_default_construct_child_list (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x8CCD1FD: orte_odls_default_launch_local_procs (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/openmpi/mca_odls_default.so) > ==102997== by 0x4C5BAC7: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A870: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA47: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x40C88C: orte_debugger_init_after_spawn (orterun.c:2904) > ==102997== by 0x405C4F: orterun (orterun.c:921) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x61a3070 is 16 bytes inside a block of size 19 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA81021: strdup (in /lib64/libc-2.12.so) > ==102997== by 0x40A30F: create_app (orterun.c:2180) > ==102997== by 0x408ACD: parse_locals (orterun.c:1681) > ==102997== by 0x404D1E: orterun (orterun.c:658) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Too many processors in X direction: 2 1 > [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 > [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack > [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c > [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c > [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: -ksp_gmres_restart 300 > [0]PETSC ERROR: -ksp_type gmres > [0]PETSC ERROR: -log_view > [0]PETSC ERROR: -pc_asm_overlap 4 > [0]PETSC ERROR: -pc_type asm > [0]PETSC ERROR: -snes_atol 1.0e-20 > [0]PETSC ERROR: -snes_linesearch_type bt > [0]PETSC ERROR: -snes_mf > [0]PETSC ERROR: -snes_monitor > [0]PETSC ERROR: -snes_type newtontr > [0]PETSC ERROR: -sub_ksp_type preonly > [0]PETSC ERROR: -sub_pc_type lu > [0]PETSC ERROR: -ts_adapt_monitor > [0]PETSC ERROR: -ts_max_snes_failures -1 > [0]PETSC ERROR: -ts_monitor > [0]PETSC ERROR: -ts_type bdf > [0]PETSC ERROR: -ts_view > [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Too many processors in X direction: 2 1 > [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 > [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack > [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c > [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c > [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: -ksp_gmres_restart 300 > [0]PETSC ERROR: -ksp_type gmres > [0]PETSC ERROR: -log_view > [0]PETSC ERROR: -pc_asm_overlap 4 > [0]PETSC ERROR: -pc_type asm > [0]PETSC ERROR: -snes_atol 1.0e-20 > [0]PETSC ERROR: -snes_linesearch_type bt > [0]PETSC ERROR: -snes_mf > [0]PETSC ERROR: -snes_monitor > [0]PETSC ERROR: -snes_type newtontr > [0]PETSC ERROR: -sub_ksp_type preonly > [0]PETSC ERROR: -sub_pc_type lu > [0]PETSC ERROR: -ts_adapt_monitor > [0]PETSC ERROR: -ts_max_snes_failures -1 > [0]PETSC ERROR: -ts_monitor > [0]PETSC ERROR: -ts_type bdf > [0]PETSC ERROR: -ts_view > [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- > [0]PETSC ERROR: --------------------- Error Message -------------------------------------------------------------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Too many processors in X direction: 2 1 > [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 > [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack > [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c > [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c > [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: -ksp_gmres_restart 300 > [0]PETSC ERROR: -ksp_type gmres > [0]PETSC ERROR: -log_view > [0]PETSC ERROR: -pc_asm_overlap 4 > [0]PETSC ERROR: -pc_type asm > [0]PETSC ERROR: -snes_atol 1.0e-20 > [0]PETSC ERROR: -snes_linesearch_type bt > [0]PETSC ERROR: -snes_mf > [0]PETSC ERROR: -snes_monitor > [0]PETSC ERROR: -snes_type newtontr > [0]PETSC ERROR: -sub_ksp_type preonly > [0]PETSC ERROR: -sub_pc_type lu > [0]PETSC ERROR: -ts_adapt_monitor > [0]PETSC ERROR: -ts_max_snes_failures -1 > [0]PETSC ERROR: -ts_monitor > [0]PETSC ERROR: -ts_type bdf > [0]PETSC ERROR: -ts_view > [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- > [0]PETSC ERROR: Argument out of range > [0]PETSC ERROR: Too many processors in X direction: 2 1 > [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: ./try3-jacob-3.out on a one named mike372 by skavou1 Wed Jul 19 10:06:02 2017 > [0]PETSC ERROR: Configure options PETSC_DIR=/home/skavou1/work/petsc-3.7.5 PETSC_ARCH=one --download-cmake --download-mpich --download-fblaslapack --with-debugging --download-superlu_dist --download-parmetis --download-metis --download-ptscotch --download-mumps --download-hypre --download-scalapack > [0]PETSC ERROR: #1 DMSetUp_DA_3D() line 224 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #2 DMSetUp_DA() line 27 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/dareg.c > [0]PETSC ERROR: #3 DMSetUp() line 744 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/interface/dm.c > [0]PETSC ERROR: #4 DMDACreate3d() line 1446 in /ddnB/work/skavou1/petsc-3.7.5/src/dm/impls/da/da3.c > [0]PETSC ERROR: #5 main() line 208 in /home/skavou1/work/adaptive/July/one-numceation6/try3-jacob-3.c > [0]PETSC ERROR: PETSc Option Table entries: > [0]PETSC ERROR: -ksp_gmres_restart 300 > [0]PETSC ERROR: -ksp_type gmres > [0]PETSC ERROR: -log_view > [0]PETSC ERROR: -pc_asm_overlap 4 > [0]PETSC ERROR: -pc_type asm > [0]PETSC ERROR: -snes_atol 1.0e-20 > [0]PETSC ERROR: -snes_linesearch_type bt > [0]PETSC ERROR: -snes_mf > [0]PETSC ERROR: -snes_monitor > [0]PETSC ERROR: -snes_type newtontr > [0]PETSC ERROR: -sub_ksp_type preonly > [0]PETSC ERROR: -sub_pc_type lu > [0]PETSC ERROR: -ts_adapt_monitor > [0]PETSC ERROR: -ts_max_snes_failures -1 > [0]PETSC ERROR: -ts_monitor > [0]PETSC ERROR: -ts_type bdf > [0]PETSC ERROR: -ts_view > [0]PETSC ERROR: ----------------End of Error Message -------send entire error message to petsc-maint at mcs.anl.gov---------- > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > [unset]: aborting job: > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > [unset]: aborting job: > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > [unset]: aborting job: > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > [unset]: aborting job: > application called MPI_Abort(MPI_COMM_WORLD, 63) - process 0 > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68E02: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b66e0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68E02: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b6750 is 32 bytes inside a block of size 35 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C486B9: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b66e0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x653b270 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C486FB: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA83: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA98: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EAB8: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB8D: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EB92: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EB96: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB672D: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C48747: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C487A3: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x653b170 is 0 bytes inside a block of size 2 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C46EBA: orte_util_convert_vpid_to_string (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C486CA: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C487E2: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9B4: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C487E2: orte_session_dir_finalize (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66CF6: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C66C93: orte_odls_base_notify_iof_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AE8D: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4844C: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x64b66e0 is 0 bytes inside a block of size 5 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C484C2: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x654ea00 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C48476: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C484C2: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6720E: check_proc_complete (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C68D20: orte_base_default_waitpid_fired (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5AF39: process_commands (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C5A41D: orte_daemon_cmd_processor (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA2DE: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== Address 0x654f550 is 16 bytes inside a block of size 23 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40E548: __intel_sse2_strlen (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA410: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== Address 0x654fd40 is 64 bytes inside a block of size 67 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E977: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA44F: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA44F: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA75: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== Address 0x654fd40 is 64 bytes inside a block of size 67 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA479: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBC5: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA479: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Invalid read of size 8 > ==102997== at 0x40EA47: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA46A: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== Address 0x654fe68 is 24 bytes inside a block of size 28 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x40EF6D: __intel_sse2_strdup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40E995: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA499: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40E9EA: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CBA499: opal_show_help_vstring (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C49B88: orte_show_help (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x407180: dump_aborted_procs (orterun.c:1207) > ==102997== by 0x405E74: job_completed (orterun.c:957) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== > -------------------------------------------------------------------------- > mpiexec noticed that the job aborted, but has no info as to the process > that caused that situation. > -------------------------------------------------------------------------- > ==102997== Invalid read of size 8 > ==102997== at 0x4CB65AE: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C484EC: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4063E5: just_quit (orterun.c:1046) > ==102997== by 0x406302: job_completed (orterun.c:1016) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== Address 0x6550f20 is 0 bytes inside a block of size 6 alloc'd > ==102997== at 0x4A06A2E: malloc (vg_replace_malloc.c:270) > ==102997== by 0x3C8BA6F41F: vasprintf (in /lib64/libc-2.12.so) > ==102997== by 0x3C8BA4F307: asprintf (in /lib64/libc-2.12.so) > ==102997== by 0x4C48476: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4063E5: just_quit (orterun.c:1046) > ==102997== by 0x406302: job_completed (orterun.c:1016) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x4CB6675: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C484EC: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4063E5: just_quit (orterun.c:1046) > ==102997== by 0x406302: job_completed (orterun.c:1016) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x405C54: orterun (orterun.c:925) > ==102997== by 0x4041A3: main (main.c:13) > ==102997== > ==102997== Use of uninitialised value of size 8 > ==102997== at 0x40EBB3: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4853B: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4063E5: just_quit (orterun.c:1046) > ==102997== by 0x406302: job_completed (orterun.c:1016) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== Conditional jump or move depends on uninitialised value(s) > ==102997== at 0x40EA59: __intel_sse2_strcat (in /home/packages/openmpi/1.6.2/Intel-13.0.0/bin/orterun) > ==102997== by 0x4CB6793: opal_os_path (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4CB625C: opal_os_dirpath_destroy (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C4853B: orte_session_dir_cleanup (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4063E5: just_quit (orterun.c:1046) > ==102997== by 0x406302: job_completed (orterun.c:1016) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C843D7: opal_progress (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C452FC: orte_trigger_event (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C72DE0: orte_plm_base_check_job_completed (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C6F8C3: process_msg (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== by 0x4C9DE7B: opal_event_base_loop (in /home/packages/openmpi/1.6.2/Intel-13.0.0/lib/libopen-rte.so.4.0.0) > ==102997== > ==102997== > ==102997== HEAP SUMMARY: > ==102997== in use at exit: 411,245 bytes in 3,053 blocks > ==102997== total heap usage: 8,975 allocs, 5,922 frees, 12,560,021 bytes allocated > ==102997== > ==102997== LEAK SUMMARY: > ==102997== definitely lost: 52,793 bytes in 43 blocks > ==102997== indirectly lost: 17,831 bytes in 61 blocks > ==102997== possibly lost: 0 bytes in 0 blocks > ==102997== still reachable: 340,621 bytes in 2,949 blocks > ==102997== suppressed: 0 bytes in 0 blocks > ==102997== Rerun with --leak-check=full to see details of leaked memory > ==102997== > ==102997== For counts of detected and suppressed errors, rerun with: -v > ==102997== Use --track-origins=yes to see where uninitialised values come from > ==102997== ERROR SUMMARY: 45427 errors from 796 contexts (suppressed: 6 from 6) -------------- next part -------------- An HTML attachment was scrubbed... URL: From rlwalker at usc.edu Wed Jul 19 20:56:22 2017 From: rlwalker at usc.edu (Robert Walker) Date: Wed, 19 Jul 2017 18:56:22 -0700 Subject: [petsc-users] Undeclared Error for Magma Dynamics Code Message-ID: Hello, I am having an issue compiling code that I got from Matt at the crustal dynamics workshop a while back...it states that DM_FOREST_****** type terms are undeclared. I want to say that Matt advised me on what the issue was at the conference, but of course the laptop I was using promptly died upon arriving home. Below is the error output after running "make magma": Thank you for your help. ################################################################### mpicc -o magma.o -c -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -fstack-protector -fvisibility=hidden -O3 -march=native -mtune=native -I. -I/home/dockimble/PETSc/petsc/include -I/home/dockimble/PETSc/petsc/linux-gnu-c-debug/include `pwd`/magma.c /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ?CreateMesh?: /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138:105: error: incompatible type for argument 2 of ?DMSetPeriodicity? if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, user->bd);CHKERRQ(ierr);} ^ In file included from /home/dockimble/PETSc/petsc/include/petscdmda.h:4:0, from /home/dockimble/PETSc/petsc/include/petsc.h:12, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscdm.h:131:29: note: expected ?PetscBool {aka enum }? but argument is of type ?PetscReal * {aka double *}? PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,const PetscReal[],const PetscReal[],const DMBoundaryType[]); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138:117: warning: passing argument 4 of ?DMSetPeriodicity? from incompatible pointer type [-Wincompatible-pointer-types] if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, user->bd);CHKERRQ(ierr);} ^ In file included from /home/dockimble/PETSc/petsc/include/petscdmda.h:4:0, from /home/dockimble/PETSc/petsc/include/petsc.h:12, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscdm.h:131:29: note: expected ?const PetscReal * {aka const double *}? but argument is of type ?DMBoundaryType * {aka enum *}? PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,const PetscReal[],const PetscReal[],const DMBoundaryType[]); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138:83: error: too few arguments to function ?DMSetPeriodicity? if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, user->bd);CHKERRQ(ierr);} ^ In file included from /home/dockimble/PETSc/petsc/include/petscdmda.h:4:0, from /home/dockimble/PETSc/petsc/include/petsc.h:12, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscdm.h:131:29: note: declared here PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,const PetscReal[],const PetscReal[],const DMBoundaryType[]); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ?SetupProblem?: /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:191:40: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, f1_momentum_balance);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:191:62: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, f1_momentum_balance);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:192:40: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_mass_balance, f1_mass_balance);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:192:62: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_mass_balance, f1_mass_balance);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:193:40: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 2, f0_passive_advection, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:193:62: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 2, f0_passive_advection, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:194:45: warning: passing argument 3 of ?PetscDSSetRiemannSolver? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetRiemannSolver(prob, 2, riemann_coupled_advection);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:213:29: note: expected ?void (*)(PetscInt, PetscInt, const PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, PetscInt, const PetscScalar *, PetscScalar *, void *) {aka void (*)(int, int, const double *, const double *, const double *, const double *, int, const double *, double *, void *)}? but argument is of type ?void (*)(PetscInt, PetscInt, const PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, PetscScalar *, void *) {aka void (*)(int, int, const double *, const double *, const double *, const double *, double *, void *)}? PETSC_EXTERN PetscErrorCode PetscDSSetRiemannSolver(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:195:75: warning: passing argument 7 of ?PetscDSSetJacobianPreconditioner? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobianPreconditioner(prob, 0, 0, NULL, NULL, NULL, g3_magma_uu);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:196:69: warning: passing argument 6 of ?PetscDSSetJacobianPreconditioner? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobianPreconditioner(prob, 0, 1, NULL, NULL, g2_stokes_up, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:197:63: warning: passing argument 5 of ?PetscDSSetJacobianPreconditioner? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobianPreconditioner(prob, 1, 0, NULL, g1_stokes_pu, NULL, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:198:57: warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, NULL, NULL, g3_magma_pp);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:198:84: warning: passing argument 7 of ?PetscDSSetJacobianPreconditioner? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, NULL, NULL, g3_magma_pp);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:199:57: warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobianPreconditioner(prob, 2, 2, g0_stokes_phi, NULL, NULL, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:214:40: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, f1_vector_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:214:56: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, f1_vector_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:215:40: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_scalar_zero, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:215:56: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_scalar_zero, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:216:40: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 2, f0_advection, f1_advection);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:216:56: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 2, f0_advection, f1_advection);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:217:45: warning: passing argument 3 of ?PetscDSSetRiemannSolver? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetRiemannSolver(prob, 2, riemann_coupled_advection);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:213:29: note: expected ?void (*)(PetscInt, PetscInt, const PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, PetscInt, const PetscScalar *, PetscScalar *, void *) {aka void (*)(int, int, const double *, const double *, const double *, const double *, int, const double *, double *, void *)}? but argument is of type ?void (*)(PetscInt, PetscInt, const PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, PetscScalar *, void *) {aka void (*)(int, int, const double *, const double *, const double *, const double *, double *, void *)}? PETSC_EXTERN PetscErrorCode PetscDSSetRiemannSolver(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:226:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_stokes_periodic_u, f1_stokes_u);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:226:64: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_stokes_periodic_u, f1_stokes_u);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:228:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_stokes_u, f1_stokes_u);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:228:64: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_stokes_u, f1_stokes_u);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:230:40: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_stokes_p, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:230:53: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_stokes_p, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:231:40: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:231:53: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:232:61: warning: passing argument 7 of ?PetscDSSetJacobian? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobian(prob, 0, 0, NULL, NULL, NULL, g3_stokes_uu);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:233:55: warning: passing argument 6 of ?PetscDSSetJacobian? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobian(prob, 0, 1, NULL, NULL, g2_stokes_up, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:234:49: warning: passing argument 5 of ?PetscDSSetJacobian? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobian(prob, 1, 0, NULL, g1_stokes_pu, NULL, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:235:43: warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobian(prob, 2, 2, g0_stokes_phi, NULL, NULL, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:236:75: warning: passing argument 7 of ?PetscDSSetJacobianPreconditioner? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobianPreconditioner(prob, 0, 0, NULL, NULL, NULL, g3_stokes_uu);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:237:57: warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, NULL, NULL, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:238:57: warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobianPreconditioner(prob, 2, 2, g0_stokes_phi, NULL, NULL, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:261:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_lap_periodic_u, f1_lap_u);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:261:64: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_lap_periodic_u, f1_lap_u);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:262:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:262:64: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:265:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_lap_u, f1_lap_u);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:265:55: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_lap_u, f1_lap_u);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:266:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_pressure, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:266:55: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_pressure, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:269:40: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:269:53: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:270:61: warning: passing argument 7 of ?PetscDSSetJacobian? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobian(prob, 0, 0, NULL, NULL, NULL, g3_uu);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:271:43: warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobian(prob, 1, 1, g0_pressure, NULL, NULL, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:272:43: warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobian(prob, 2, 2, g0_pressure, NULL, NULL, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:294:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_doubly_periodic_velocity, f1_vector_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:294:71: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_doubly_periodic_velocity, f1_vector_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:295:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_doubly_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:295:71: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_doubly_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:297:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_periodic_velocity, f1_vector_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:297:64: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_periodic_velocity, f1_vector_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:298:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:298:64: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:300:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_velocity, f1_vector_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:300:55: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 0, f0_velocity, f1_vector_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:301:42: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_pressure, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:301:55: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 1, f0_pressure, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:303:40: warning: passing argument 3 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:303:53: warning: passing argument 4 of ?PetscDSSetResidual? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:304:43: warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobian(prob, 0, 0, g0_velocity, NULL, NULL, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:305:43: warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobian(prob, 1, 1, g0_pressure, NULL, NULL, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:306:43: warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetJacobian(prob, 2, 2, g0_pressure, NULL, NULL, NULL);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ?BenchmarkMonitor?: /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:38: error: incompatible type for argument 2 of ?DMProjectField? ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0, from /home/dockimble/PETSc/petsc/include/petscts.h:7, from /home/dockimble/PETSc/petsc/include/petsc.h:26, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected ?PetscReal {aka double}? but argument is of type ?Vec {aka struct _p_Vec *}? PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:41: warning: passing argument 3 of ?DMProjectField? from incompatible pointer type [-Wincompatible-pointer-types] ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0, from /home/dockimble/PETSc/petsc/include/petscts.h:7, from /home/dockimble/PETSc/petsc/include/petsc.h:26, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected ?Vec {aka struct _p_Vec *}? but argument is of type ?void (**)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (**)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:48: warning: passing argument 4 of ?DMProjectField? makes pointer from integer without a cast [-Wint-conversion] ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0, from /home/dockimble/PETSc/petsc/include/petscts.h:7, from /home/dockimble/PETSc/petsc/include/petsc.h:26, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected ?void (**)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (**)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?int? PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:63: error: incompatible type for argument 5 of ?DMProjectField? ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0, from /home/dockimble/PETSc/petsc/include/petscts.h:7, from /home/dockimble/PETSc/petsc/include/petsc.h:26, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected ?InsertMode {aka enum }? but argument is of type ?Vec {aka struct _p_Vec *}? PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:14: error: too few arguments to function ?DMProjectField? ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0, from /home/dockimble/PETSc/petsc/include/petscts.h:7, from /home/dockimble/PETSc/petsc/include/petsc.h:26, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: declared here PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ?CreateErrorFE?: /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:841:54: error: incompatible type for argument 5 of ?PetscDTGaussTensorQuadrature? ierr = PetscDTGaussTensorQuadrature(dim,2,-1.0,1.0,&quad);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, from /home/dockimble/PETSc/petsc/include/petsc.h:12, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscdt.h:34:29: note: expected ?PetscReal {aka double}? but argument is of type ?struct _p_PetscQuadrature **? PETSC_EXTERN PetscErrorCode PetscDTGaussTensorQuadrature(PetscInt,PetscInt,PetscInt,PetscReal,PetscReal,PetscQuadrature*); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:841:10: error: too few arguments to function ?PetscDTGaussTensorQuadrature? ierr = PetscDTGaussTensorQuadrature(dim,2,-1.0,1.0,&quad);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, from /home/dockimble/PETSc/petsc/include/petsc.h:12, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscdt.h:34:29: note: declared here PETSC_EXTERN PetscErrorCode PetscDTGaussTensorQuadrature(PetscInt,PetscInt,PetscInt,PetscReal,PetscReal,PetscQuadrature*); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ?AdaptPorosityExact?: /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:970:49: error: ?DM_FOREST_REFINE? undeclared (first use in this function) ierr = DMLabelSetDefaultValue(refineLabel,DM_FOREST_REFINE);CHKERRQ(ierr); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:970:49: note: each undeclared identifier is reported only once for each function it appears in /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:971:14: warning: implicit declaration of function ?DMForestAdaptLabel? [-Wimplicit-function-declaration] ierr = DMForestAdaptLabel(dm,"adapt",&adaptedDM);CHKERRQ(ierr); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:988:46: error: ?DM_FOREST_KEEP? undeclared (first use in this function) ierr = DMLabelSetDefaultValue(adaptLabel,DM_FOREST_KEEP);CHKERRQ(ierr); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:995:45: error: ?DM_FOREST_COARSEN? undeclared (first use in this function) ierr = DMLabelSetValue(adaptLabel,i,DM_FOREST_COARSEN);CHKERRQ(ierr); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ?AdaptPorosityGradient?: /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1151:51: warning: passing argument 4 of ?PetscQuadratureGetData? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscQuadratureGetData(q,&dim,&nPoints,&points,&weights);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, from /home/dockimble/PETSc/petsc/include/petsc.h:12, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscdt.h:24:29: note: expected ?PetscInt * {aka int *}? but argument is of type ?const PetscReal ** {aka const double **}? PETSC_EXTERN PetscErrorCode PetscQuadratureGetData(PetscQuadrature, PetscInt*, PetscInt*, PetscInt*, const PetscReal *[], const PetscReal *[]); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1151:12: error: too few arguments to function ?PetscQuadratureGetData? ierr = PetscQuadratureGetData(q,&dim,&nPoints,&points,&weights);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, from /home/dockimble/PETSc/petsc/include/petsc.h:12, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscdt.h:24:29: note: declared here PETSC_EXTERN PetscErrorCode PetscQuadratureGetData(PetscQuadrature, PetscInt*, PetscInt*, PetscInt*, const PetscReal *[], const PetscReal *[]); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1250:49: error: ?DM_FOREST_REFINE? undeclared (first use in this function) ierr = DMLabelSetDefaultValue(refineLabel,DM_FOREST_REFINE);CHKERRQ(ierr); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1269:46: error: ?DM_FOREST_KEEP? undeclared (first use in this function) ierr = DMLabelSetDefaultValue(adaptLabel,DM_FOREST_KEEP);CHKERRQ(ierr); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1283:47: error: ?DM_FOREST_COARSEN? undeclared (first use in this function) ierr = DMLabelSetValue(adaptLabel,i,DM_FOREST_COARSEN);CHKERRQ(ierr); ^ /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ?main?: /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1592:43: warning: passing argument 3 of ?PetscDSSetObjective? from incompatible pointer type [-Wincompatible-pointer-types] ierr = PetscDSSetObjective(prob, 2, compactionRateError);CHKERRQ(ierr); ^ In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4: /home/dockimble/PETSc/petsc/include/petscds.h:83:29: note: expected ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, int, const double *, double *)}? but argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double, const double *, double *)}? PETSC_EXTERN PetscErrorCode PetscDSSetObjective(PetscDS, PetscInt, ^ /home/dockimble/PETSc/petsc/lib/petsc/conf/rules:401: recipe for target 'magma.o' failed make: *** [magma.o] Error 1 Robert L. Walker MS Petroleum Engineering Mork Family Department of Chemicals and Materials Sciences University of Southern California ---------------------------------------------- Mobile US: +1 (213) - 290 -7101 Mobile EU: +34 62 274 66 40 rlwalker at usc.edu -------------- next part -------------- An HTML attachment was scrubbed... URL: From luca.mechelli at uni-konstanz.de Thu Jul 20 05:39:20 2017 From: luca.mechelli at uni-konstanz.de (Luca Mechelli) Date: Thu, 20 Jul 2017 12:39:20 +0200 Subject: [petsc-users] Store the ILU preconditioner matrices Message-ID: <51c3-59708880-1-35dbd440@75373327> Dear all, Does someone know how to get the ILU matrices ( L, U and the permutation matrix P) computed by the ILU preconditioner? Like the Matlab command: [L,U,P]= ilu(A,setup) Is this possible in PETSc? Thank you a lot, Best regards, Luca Mechelli -- Luca Mechelli Wissenschaftlicher Mitarbeiter Arbeitsgruppe Numerik Fachbereich Mathematik und Statistik Universit?t Konstanz Fach D 198 D-78457 Konstanz Telefon: +49-(0) 7531-88-4637 From knepley at gmail.com Thu Jul 20 06:10:10 2017 From: knepley at gmail.com (Matthew Knepley) Date: Thu, 20 Jul 2017 07:10:10 -0400 Subject: [petsc-users] Store the ILU preconditioner matrices In-Reply-To: <51c3-59708880-1-35dbd440@75373327> References: <51c3-59708880-1-35dbd440@75373327> Message-ID: On Thu, Jul 20, 2017 at 6:39 AM, Luca Mechelli < luca.mechelli at uni-konstanz.de> wrote: > Dear all, > > Does someone know how to get the ILU matrices ( L, U and the permutation > matrix P) computed by the ILU preconditioner? > It is not part of the interface. Third party packages have them in proprietary formats that may change. Thanks, Matt > Like the Matlab command: [L,U,P]= ilu(A,setup) > Is this possible in PETSc? > > Thank you a lot, > Best regards, > Luca Mechelli > > -- > Luca Mechelli > Wissenschaftlicher Mitarbeiter > Arbeitsgruppe Numerik > Fachbereich Mathematik und Statistik > > Universit?t Konstanz > Fach D 198 > D-78457 Konstanz > Telefon: +49-(0) 7531-88-4637 > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From luca.mechelli at uni-konstanz.de Thu Jul 20 07:30:22 2017 From: luca.mechelli at uni-konstanz.de (Luca Mechelli) Date: Thu, 20 Jul 2017 14:30:22 +0200 Subject: [petsc-users] =?utf-8?b?Pz09P3V0Zi04P3E/ICBTdG9yZSB0aGUgSUxVIHBy?= =?utf-8?q?econditioner_matrices?= In-Reply-To: Message-ID: <6710-5970a280-27-201ef080@44374031> Ok, Thank you for answer! Luca -- Luca Mechelli Wissenschaftlicher Mitarbeiter Arbeitsgruppe Numerik Fachbereich Mathematik und Statistik Universit?t Konstanz Fach D 198 D-78457 Konstanz Telefon: +49-(0) 7531-88-4637 Il giorno Giovedi, 20 Luglio, 2017 13:10 CEST, Matthew Knepley ha scritto: > On Thu, Jul 20, 2017 at 6:39 AM, Luca Mechelli < > luca.mechelli at uni-konstanz.de> wrote: > > > Dear all, > > > > Does someone know how to get the ILU matrices ( L, U and the permutation > > matrix P) computed by the ILU preconditioner? > > > > It is not part of the interface. Third party packages have them in > proprietary formats that may change. > > Thanks, > > Matt > > > > Like the Matlab command: [L,U,P]= ilu(A,setup) > > Is this possible in PETSc? > > > > Thank you a lot, > > Best regards, > > Luca Mechelli > > > > -- > > Luca Mechelli > > Wissenschaftlicher Mitarbeiter > > Arbeitsgruppe Numerik > > Fachbereich Mathematik und Statistik > > > > Universit?t Konstanz > > Fach D 198 > > D-78457 Konstanz > > Telefon: +49-(0) 7531-88-4637 > > > > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ From steven_wildman_wong at hotmail.com Thu Jul 20 17:37:18 2017 From: steven_wildman_wong at hotmail.com (Steven Wong) Date: Thu, 20 Jul 2017 22:37:18 +0000 Subject: [petsc-users] Compiling with Intel MPI options Message-ID: If I use on a Centos 7.2 system ./configure --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort --with-blas-lapack-dir=/opt/intel/mkl/lib/intel64 I get =============================================================================== Configuring PETSc to compile on your system =============================================================================== TESTING: checkCCompiler from config.setCompilers(config/BuildSystem/config/setCompilers.py:553) ******************************************************************************* UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log for details): ------------------------------------------------------------------------------- C compiler you provided with -with-cc=mpiicc does not work. C compiler mpiicc is broken! It is returning a zero error when the linking failed! Either 1) switch to another compiler suite or 2) report this entire error message to your compiler/linker suite vendor and ask for fix for this issue. ******************************************************************************* (configure.log attached) However, if I use ./configure --with-cc=icc --with-cxx=icpc --with-fc=ifort --with-blas-lapack-dir=/opt/intel/mkl/lib/intel64 --with-mpi=0 All is fine (see configure.log.nompi) We don't have issues using mpiifort or mpiicc if I compile my own code. What are we missing? Thanks in advance. -------------- next part -------------- A non-text attachment was scrubbed... Name: configure.log Type: text/x-log Size: 26776 bytes Desc: configure.log URL: -------------- next part -------------- An embedded and charset-unspecified text was scrubbed... Name: configure.log.nompi URL: From bsmith at mcs.anl.gov Thu Jul 20 17:47:04 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Thu, 20 Jul 2017 17:47:04 -0500 Subject: [petsc-users] Compiling with Intel MPI options In-Reply-To: References: Message-ID: Steven, We are linking against a non-existant library as a test of the linker, the linker is returning without an error code. This means that we cannot trust the error codes returned from the linker which means that our configure tests will not work. First thing to do is check if you have any later versions of Intel MPI compilers installed on your systems or if there are any updates to the compilers. Check with your systems support if you don't install the compilers etc yourself. Barry > On Jul 20, 2017, at 5:37 PM, Steven Wong wrote: > > If I use on a Centos 7.2 system > ./configure --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort > --with-blas-lapack-dir=/opt/intel/mkl/lib/intel64 > > I get > =============================================================================== > Configuring PETSc to compile on your > system > =============================================================================== > TESTING: checkCCompiler from > config.setCompilers(config/BuildSystem/config/setCompilers.py:553) > ******************************************************************************* > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log > for details): > ------------------------------------------------------------------------------- > C compiler you provided with -with-cc=mpiicc does not work. > C compiler mpiicc is broken! It is returning a zero error when the > linking failed! Either > 1) switch to another compiler suite or > 2) report this entire error message to your compiler/linker suite > vendor and ask for fix for this issue. > ******************************************************************************* > (configure.log attached) > > However, if I use > ./configure --with-cc=icc --with-cxx=icpc --with-fc=ifort > --with-blas-lapack-dir=/opt/intel/mkl/lib/intel64 --with-mpi=0 > All is fine (see configure.log.nompi) > > We don't have issues using mpiifort or mpiicc if I compile my own code. > What are we missing? Thanks in advance. > From balay at mcs.anl.gov Thu Jul 20 18:23:43 2017 From: balay at mcs.anl.gov (Satish Balay) Date: Thu, 20 Jul 2017 18:23:43 -0500 Subject: [petsc-users] Compiling with Intel MPI options In-Reply-To: References: Message-ID: Yeah one of the versions of Intel MPI had these buggy compilers. Switching to a newer (or older) IMPI would avoid this problem. Alternative is to figureout mpi include and lib options [from mpiicc -show, mpiifort -show etc..] - and use: --with-cc=icc --with-fc=ifort --with-mpi-include=.. --with-mpi-lib=... Or use --download-mpich [if suitable] Satish On Thu, 20 Jul 2017, Barry Smith wrote: > > Steven, > > We are linking against a non-existant library as a test of the linker, the linker is returning without an error code. This means that we cannot trust the error codes returned from the linker which means that our configure tests will not work. > > First thing to do is check if you have any later versions of Intel MPI compilers installed on your systems or if there are any updates to the compilers. Check with your systems support if you don't install the compilers etc yourself. > > Barry > > > > > On Jul 20, 2017, at 5:37 PM, Steven Wong wrote: > > > > If I use on a Centos 7.2 system > > ./configure --with-cc=mpiicc --with-cxx=mpiicpc --with-fc=mpiifort > > --with-blas-lapack-dir=/opt/intel/mkl/lib/intel64 > > > > I get > > =============================================================================== > > Configuring PETSc to compile on your > > system > > =============================================================================== > > TESTING: checkCCompiler from > > config.setCompilers(config/BuildSystem/config/setCompilers.py:553) > > ******************************************************************************* > > UNABLE to CONFIGURE with GIVEN OPTIONS (see configure.log > > for details): > > ------------------------------------------------------------------------------- > > C compiler you provided with -with-cc=mpiicc does not work. > > C compiler mpiicc is broken! It is returning a zero error when the > > linking failed! Either > > 1) switch to another compiler suite or > > 2) report this entire error message to your compiler/linker suite > > vendor and ask for fix for this issue. > > ******************************************************************************* > > (configure.log attached) > > > > However, if I use > > ./configure --with-cc=icc --with-cxx=icpc --with-fc=ifort > > --with-blas-lapack-dir=/opt/intel/mkl/lib/intel64 --with-mpi=0 > > All is fine (see configure.log.nompi) > > > > We don't have issues using mpiifort or mpiicc if I compile my own code. > > What are we missing? Thanks in advance. > > > > From knepley at gmail.com Fri Jul 21 09:14:43 2017 From: knepley at gmail.com (Matthew Knepley) Date: Fri, 21 Jul 2017 10:14:43 -0400 Subject: [petsc-users] Undeclared Error for Magma Dynamics Code In-Reply-To: References: Message-ID: I have pushed updates for the code. Now I have to update the regression check code. Thanks, Matt On Wed, Jul 19, 2017 at 9:56 PM, Robert Walker wrote: > Hello, > > I am having an issue compiling code that I got from Matt at the crustal > dynamics workshop a while back...it states that DM_FOREST_****** type terms > are undeclared. I want to say that Matt advised me on what the issue was at > the conference, but of course the laptop I was using promptly died upon > arriving home. Below is the error output after running "make magma": > > Thank you for your help. > ################################################################### > > mpicc -o magma.o -c -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing > -Wno-unknown-pragmas -fstack-protector -fvisibility=hidden -O3 > -march=native -mtune=native -I. -I/home/dockimble/PETSc/petsc/include > -I/home/dockimble/PETSc/petsc/linux-gnu-c-debug/include `pwd`/magma.c > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function > ?CreateMesh?: > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138:105: error: > incompatible type for argument 2 of ?DMSetPeriodicity? > if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = > 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, > user->bd);CHKERRQ(ierr);} > > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscdmda.h:4:0, > from /home/dockimble/PETSc/petsc/include/petsc.h:12, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscdm.h:131:29: note: expected > ?PetscBool {aka enum }? but argument is of type ?PetscReal * > {aka double *}? > PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,const > PetscReal[],const PetscReal[],const DMBoundaryType[]); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138:117: > warning: passing argument 4 of ?DMSetPeriodicity? from incompatible pointer > type [-Wincompatible-pointer-types] > if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = > 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, > user->bd);CHKERRQ(ierr);} > > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscdmda.h:4:0, > from /home/dockimble/PETSc/petsc/include/petsc.h:12, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscdm.h:131:29: note: expected > ?const PetscReal * {aka const double *}? but argument is of type > ?DMBoundaryType * {aka enum *}? > PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,const > PetscReal[],const PetscReal[],const DMBoundaryType[]); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138:83: error: > too few arguments to function ?DMSetPeriodicity? > if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = > 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, > user->bd);CHKERRQ(ierr);} > > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscdmda.h:4:0, > from /home/dockimble/PETSc/petsc/include/petsc.h:12, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscdm.h:131:29: note: declared here > PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,const > PetscReal[],const PetscReal[],const DMBoundaryType[]); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function > ?SetupProblem?: > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:191:40: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, > f1_momentum_balance);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:191:62: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, > f1_momentum_balance);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:192:40: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_mass_balance, > f1_mass_balance);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:192:62: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_mass_balance, > f1_mass_balance);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:193:40: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 2, f0_passive_advection, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:193:62: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 2, f0_passive_advection, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:194:45: > warning: passing argument 3 of ?PetscDSSetRiemannSolver? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetRiemannSolver(prob, 2, riemann_coupled_advection); > CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:213:29: note: expected > ?void (*)(PetscInt, PetscInt, const PetscReal *, const PetscReal *, const > PetscScalar *, const PetscScalar *, PetscInt, const PetscScalar *, > PetscScalar *, void *) {aka void (*)(int, int, const double *, const > double *, const double *, const double *, int, const double *, double *, > void *)}? but argument is of type ?void (*)(PetscInt, PetscInt, const > PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, > PetscScalar *, void *) {aka void (*)(int, int, const double *, const > double *, const double *, const double *, double *, void *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetRiemannSolver(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:195:75: > warning: passing argument 7 of ?PetscDSSetJacobianPreconditioner? from > incompatible pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobianPreconditioner(prob, 0, 0, NULL, NULL, > NULL, g3_magma_uu);CHKERRQ(ierr); > > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, > PetscInt, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:196:69: > warning: passing argument 6 of ?PetscDSSetJacobianPreconditioner? from > incompatible pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobianPreconditioner(prob, 0, 1, NULL, NULL, > g2_stokes_up, NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, > PetscInt, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:197:63: > warning: passing argument 5 of ?PetscDSSetJacobianPreconditioner? from > incompatible pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobianPreconditioner(prob, 1, 0, NULL, > g1_stokes_pu, NULL, NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, > PetscInt, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:198:57: > warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from > incompatible pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, > NULL, NULL, g3_magma_pp);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, > PetscInt, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:198:84: > warning: passing argument 7 of ?PetscDSSetJacobianPreconditioner? from > incompatible pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, > NULL, NULL, g3_magma_pp);CHKERRQ(ierr); > > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, > PetscInt, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:199:57: > warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from > incompatible pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobianPreconditioner(prob, 2, 2, g0_stokes_phi, > NULL, NULL, NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, > PetscInt, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:214:40: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, > f1_vector_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:214:56: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, > f1_vector_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:215:40: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_scalar_zero, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:215:56: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_scalar_zero, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:216:40: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 2, f0_advection, > f1_advection);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:216:56: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 2, f0_advection, > f1_advection);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:217:45: > warning: passing argument 3 of ?PetscDSSetRiemannSolver? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetRiemannSolver(prob, 2, riemann_coupled_advection); > CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:213:29: note: expected > ?void (*)(PetscInt, PetscInt, const PetscReal *, const PetscReal *, const > PetscScalar *, const PetscScalar *, PetscInt, const PetscScalar *, > PetscScalar *, void *) {aka void (*)(int, int, const double *, const > double *, const double *, const double *, int, const double *, double *, > void *)}? but argument is of type ?void (*)(PetscInt, PetscInt, const > PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, > PetscScalar *, void *) {aka void (*)(int, int, const double *, const > double *, const double *, const double *, double *, void *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetRiemannSolver(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:226:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_stokes_periodic_u, > f1_stokes_u);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:226:64: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_stokes_periodic_u, > f1_stokes_u);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:228:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_stokes_u, > f1_stokes_u);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:228:64: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_stokes_u, > f1_stokes_u);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:230:40: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_stokes_p, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:230:53: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_stokes_p, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:231:40: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 2, f0_porosity, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:231:53: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 2, f0_porosity, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:232:61: > warning: passing argument 7 of ?PetscDSSetJacobian? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobian(prob, 0, 0, NULL, NULL, NULL, > g3_stokes_uu);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, > PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:233:55: > warning: passing argument 6 of ?PetscDSSetJacobian? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobian(prob, 0, 1, NULL, NULL, g2_stokes_up, > NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, > PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:234:49: > warning: passing argument 5 of ?PetscDSSetJacobian? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobian(prob, 1, 0, NULL, g1_stokes_pu, NULL, > NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, > PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:235:43: > warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobian(prob, 2, 2, g0_stokes_phi, NULL, NULL, > NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, > PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:236:75: > warning: passing argument 7 of ?PetscDSSetJacobianPreconditioner? from > incompatible pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobianPreconditioner(prob, 0, 0, NULL, NULL, > NULL, g3_stokes_uu);CHKERRQ(ierr); > > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, > PetscInt, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:237:57: > warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from > incompatible pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, > NULL, NULL, NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, > PetscInt, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:238:57: > warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from > incompatible pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobianPreconditioner(prob, 2, 2, g0_stokes_phi, > NULL, NULL, NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, > PetscInt, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:261:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_lap_periodic_u, > f1_lap_u);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:261:64: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_lap_periodic_u, > f1_lap_u);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:262:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:262:64: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:265:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_lap_u, > f1_lap_u);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:265:55: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_lap_u, > f1_lap_u);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:266:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_pressure, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:266:55: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_pressure, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:269:40: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 2, f0_porosity, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:269:53: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 2, f0_porosity, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:270:61: > warning: passing argument 7 of ?PetscDSSetJacobian? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobian(prob, 0, 0, NULL, NULL, NULL, > g3_uu);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, > PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:271:43: > warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobian(prob, 1, 1, g0_pressure, NULL, NULL, > NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, > PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:272:43: > warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobian(prob, 2, 2, g0_pressure, NULL, NULL, > NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, > PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:294:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_doubly_periodic_velocity, > f1_vector_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:294:71: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_doubly_periodic_velocity, > f1_vector_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:295:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_doubly_periodic_pressure, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:295:71: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_doubly_periodic_pressure, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:297:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_periodic_velocity, > f1_vector_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:297:64: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_periodic_velocity, > f1_vector_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:298:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:298:64: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:300:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_velocity, > f1_vector_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:300:55: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 0, f0_velocity, > f1_vector_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:301:42: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_pressure, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:301:55: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 1, f0_pressure, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:303:40: > warning: passing argument 3 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 2, f0_porosity, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:303:53: > warning: passing argument 4 of ?PetscDSSetResidual? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetResidual(prob, 2, f0_porosity, > f1_scalar_zero);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:304:43: > warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobian(prob, 0, 0, g0_velocity, NULL, NULL, > NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, > PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:305:43: > warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobian(prob, 1, 1, g0_pressure, NULL, NULL, > NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, > PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:306:43: > warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetJacobian(prob, 2, 2, g0_pressure, NULL, NULL, > NULL);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected > ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt > *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, > const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const > int *, const int *, const double *, const double *, const double *, const > int *, const int *, const double *, const double *, const double *, > double, double, const double *, int, const double *, double *)}? but > argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const > PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, > double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, > PetscInt, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function > ?BenchmarkMonitor?: > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:38: error: > incompatible type for argument 2 of ?DMProjectField? > ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, > C);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0, > from /home/dockimble/PETSc/petsc/include/petscts.h:7, > from /home/dockimble/PETSc/petsc/include/petsc.h:26, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected > ?PetscReal {aka double}? but argument is of type ?Vec {aka struct _p_Vec *}? > PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:41: > warning: passing argument 3 of ?DMProjectField? from incompatible pointer > type [-Wincompatible-pointer-types] > ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, > C);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0, > from /home/dockimble/PETSc/petsc/include/petscts.h:7, > from /home/dockimble/PETSc/petsc/include/petsc.h:26, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected > ?Vec {aka struct _p_Vec *}? but argument is of type ?void (**)(PetscInt, > PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar > *, const PetscScalar *, const PetscScalar *, const PetscInt *, const > PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, > PetscReal, const PetscReal *, PetscScalar *) {aka void (**)(int, int, > int, const int *, const int *, const double *, const double *, const > double *, const int *, const int *, const double *, const double *, const > double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:48: > warning: passing argument 4 of ?DMProjectField? makes pointer from integer > without a cast [-Wint-conversion] > ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, > C);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0, > from /home/dockimble/PETSc/petsc/include/petscts.h:7, > from /home/dockimble/PETSc/petsc/include/petsc.h:26, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected > ?void (**)(PetscInt, PetscInt, PetscInt, const PetscInt *, const > PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, > const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar > *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (**)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?int? > PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:63: error: > incompatible type for argument 5 of ?DMProjectField? > ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, > C);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0, > from /home/dockimble/PETSc/petsc/include/petscts.h:7, > from /home/dockimble/PETSc/petsc/include/petsc.h:26, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected > ?InsertMode {aka enum }? but argument is of type ?Vec {aka > struct _p_Vec *}? > PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:14: error: > too few arguments to function ?DMProjectField? > ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, > C);CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0, > from /home/dockimble/PETSc/petsc/include/petscts.h:7, > from /home/dockimble/PETSc/petsc/include/petsc.h:26, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: declared here > PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function > ?CreateErrorFE?: > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:841:54: error: > incompatible type for argument 5 of ?PetscDTGaussTensorQuadrature? > ierr = PetscDTGaussTensorQuadrature(dim,2,-1.0,1.0,&quad);CHKERRQ( > ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, > from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, > from /home/dockimble/PETSc/petsc/include/petsc.h:12, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscdt.h:34:29: note: expected > ?PetscReal {aka double}? but argument is of type ?struct _p_PetscQuadrature > **? > PETSC_EXTERN PetscErrorCode PetscDTGaussTensorQuadrature( > PetscInt,PetscInt,PetscInt,PetscReal,PetscReal,PetscQuadrature*); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:841:10: error: > too few arguments to function ?PetscDTGaussTensorQuadrature? > ierr = PetscDTGaussTensorQuadrature(dim,2,-1.0,1.0,&quad);CHKERRQ( > ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, > from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, > from /home/dockimble/PETSc/petsc/include/petsc.h:12, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscdt.h:34:29: note: declared here > PETSC_EXTERN PetscErrorCode PetscDTGaussTensorQuadrature( > PetscInt,PetscInt,PetscInt,PetscReal,PetscReal,PetscQuadrature*); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function > ?AdaptPorosityExact?: > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:970:49: error: > ?DM_FOREST_REFINE? undeclared (first use in this function) > ierr = DMLabelSetDefaultValue(refineLabel,DM_FOREST_REFINE); > CHKERRQ(ierr); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:970:49: note: > each undeclared identifier is reported only once for each function it > appears in > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:971:14: > warning: implicit declaration of function ?DMForestAdaptLabel? > [-Wimplicit-function-declaration] > ierr = DMForestAdaptLabel(dm,"adapt",&adaptedDM);CHKERRQ(ierr); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:988:46: error: > ?DM_FOREST_KEEP? undeclared (first use in this function) > ierr = DMLabelSetDefaultValue(adaptLabel,DM_FOREST_KEEP); > CHKERRQ(ierr); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:995:45: error: > ?DM_FOREST_COARSEN? undeclared (first use in this function) > ierr = DMLabelSetValue(adaptLabel,i,DM_FOREST_COARSEN);CHKERRQ( > ierr); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function > ?AdaptPorosityGradient?: > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1151:51: > warning: passing argument 4 of ?PetscQuadratureGetData? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscQuadratureGetData(q,&dim,&nPoints,&points,&weights); > CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, > from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, > from /home/dockimble/PETSc/petsc/include/petsc.h:12, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscdt.h:24:29: note: expected > ?PetscInt * {aka int *}? but argument is of type ?const PetscReal ** {aka > const double **}? > PETSC_EXTERN PetscErrorCode PetscQuadratureGetData(PetscQuadrature, > PetscInt*, PetscInt*, PetscInt*, const PetscReal *[], const PetscReal *[]); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1151:12: error: > too few arguments to function ?PetscQuadratureGetData? > ierr = PetscQuadratureGetData(q,&dim,&nPoints,&points,&weights); > CHKERRQ(ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, > from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, > from /home/dockimble/PETSc/petsc/include/petsc.h:12, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscdt.h:24:29: note: declared here > PETSC_EXTERN PetscErrorCode PetscQuadratureGetData(PetscQuadrature, > PetscInt*, PetscInt*, PetscInt*, const PetscReal *[], const PetscReal *[]); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1250:49: error: > ?DM_FOREST_REFINE? undeclared (first use in this function) > ierr = DMLabelSetDefaultValue(refineLabel,DM_FOREST_REFINE); > CHKERRQ(ierr); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1269:46: error: > ?DM_FOREST_KEEP? undeclared (first use in this function) > ierr = DMLabelSetDefaultValue(adaptLabel,DM_FOREST_KEEP); > CHKERRQ(ierr); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1283:47: error: > ?DM_FOREST_COARSEN? undeclared (first use in this function) > ierr = DMLabelSetValue(adaptLabel,i,DM_FOREST_COARSEN);CHKERRQ( > ierr); > ^ > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function > ?main?: > /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1592:43: > warning: passing argument 3 of ?PetscDSSetObjective? from incompatible > pointer type [-Wincompatible-pointer-types] > ierr = PetscDSSetObjective(prob, 2, compactionRateError);CHKERRQ( > ierr); > ^ > In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, > from /home/dockimble/PETSc/magma- > dynamics-problems/src/magma.c:4: > /home/dockimble/PETSc/petsc/include/petscds.h:83:29: note: expected ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const > PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, > const int *, const double *, const double *, const double *, const int *, > const int *, const double *, const double *, const double *, double, const > double *, int, const double *, double *)}? but argument is of type ?void > (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, > const PetscScalar *, const PetscScalar *, const PetscScalar *, const > PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, > const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka > void (*)(int, int, int, const int *, const int *, const double *, const > double *, const double *, const int *, const int *, const double *, const > double *, const double *, double, const double *, double *)}? > PETSC_EXTERN PetscErrorCode PetscDSSetObjective(PetscDS, PetscInt, > ^ > /home/dockimble/PETSc/petsc/lib/petsc/conf/rules:401: recipe for target > 'magma.o' failed > make: *** [magma.o] Error 1 > > > Robert L. Walker > MS Petroleum Engineering > Mork Family Department of Chemicals and Materials Sciences > University of Southern California > ---------------------------------------------- > Mobile US: +1 (213) - 290 -7101 <(213)%20290-7101> > Mobile EU: +34 62 274 66 40 > rlwalker at usc.edu > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From rlwalker at usc.edu Fri Jul 21 16:34:09 2017 From: rlwalker at usc.edu (Robert Walker) Date: Fri, 21 Jul 2017 14:34:09 -0700 Subject: [petsc-users] Undeclared Error for Magma Dynamics Code In-Reply-To: References: Message-ID: Thank you very much! Some of the tests are even working now. Just the little attempt at QC through the test runs has given an understanding about your emphasis on method of manufactured solutions test cases, and why is is perfectly justified. Robert Robert L. Walker MS Petroleum Engineering Mork Family Department of Chemicals and Materials Sciences University of Southern California ---------------------------------------------- Mobile US: +1 (213) - 290 -7101 Mobile EU: +34 62 274 66 40 rlwalker at usc.edu On Fri, Jul 21, 2017 at 7:14 AM, Matthew Knepley wrote: > I have pushed updates for the code. Now I have to update the regression > check code. > > Thanks, > > Matt > > On Wed, Jul 19, 2017 at 9:56 PM, Robert Walker wrote: > >> Hello, >> >> I am having an issue compiling code that I got from Matt at the crustal >> dynamics workshop a while back...it states that DM_FOREST_****** type terms >> are undeclared. I want to say that Matt advised me on what the issue was at >> the conference, but of course the laptop I was using promptly died upon >> arriving home. Below is the error output after running "make magma": >> >> Thank you for your help. >> ################################################################### >> >> mpicc -o magma.o -c -fPIC -Wall -Wwrite-strings -Wno-strict-aliasing >> -Wno-unknown-pragmas -fstack-protector -fvisibility=hidden -O3 >> -march=native -mtune=native -I. -I/home/dockimble/PETSc/petsc/include >> -I/home/dockimble/PETSc/petsc/linux-gnu-c-debug/include `pwd`/magma.c >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function >> ?CreateMesh?: >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138:105: >> error: incompatible type for argument 2 of ?DMSetPeriodicity? >> if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = >> 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, >> user->bd);CHKERRQ(ierr);} >> >> ^ >> In file included from /home/dockimble/PETSc/petsc/in >> clude/petscdmda.h:4:0, >> from /home/dockimble/PETSc/petsc/include/petsc.h:12, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscdm.h:131:29: note: expected >> ?PetscBool {aka enum }? but argument is of type ?PetscReal * >> {aka double *}? >> PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,const >> PetscReal[],const PetscReal[],const DMBoundaryType[]); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138:117: >> warning: passing argument 4 of ?DMSetPeriodicity? from incompatible pointer >> type [-Wincompatible-pointer-types] >> if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = >> 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, >> user->bd);CHKERRQ(ierr);} >> >> ^ >> In file included from /home/dockimble/PETSc/petsc/in >> clude/petscdmda.h:4:0, >> from /home/dockimble/PETSc/petsc/include/petsc.h:12, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscdm.h:131:29: note: expected >> ?const PetscReal * {aka const double *}? but argument is of type >> ?DMBoundaryType * {aka enum *}? >> PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,const >> PetscReal[],const PetscReal[],const DMBoundaryType[]); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138:83: error: >> too few arguments to function ?DMSetPeriodicity? >> if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = >> 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, >> user->bd);CHKERRQ(ierr);} >> >> ^ >> In file included from /home/dockimble/PETSc/petsc/in >> clude/petscdmda.h:4:0, >> from /home/dockimble/PETSc/petsc/include/petsc.h:12, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscdm.h:131:29: note: declared here >> PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,const >> PetscReal[],const PetscReal[],const DMBoundaryType[]); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function >> ?SetupProblem?: >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:191:40: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, >> f1_momentum_balance);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:191:62: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, >> f1_momentum_balance);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:192:40: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_mass_balance, >> f1_mass_balance);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:192:62: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_mass_balance, >> f1_mass_balance);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:193:40: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 2, f0_passive_advection, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:193:62: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 2, f0_passive_advection, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:194:45: >> warning: passing argument 3 of ?PetscDSSetRiemannSolver? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetRiemannSolver(prob, 2, >> riemann_coupled_advection);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:213:29: note: expected >> ?void (*)(PetscInt, PetscInt, const PetscReal *, const PetscReal *, const >> PetscScalar *, const PetscScalar *, PetscInt, const PetscScalar *, >> PetscScalar *, void *) {aka void (*)(int, int, const double *, const >> double *, const double *, const double *, int, const double *, double *, >> void *)}? but argument is of type ?void (*)(PetscInt, PetscInt, const >> PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, >> PetscScalar *, void *) {aka void (*)(int, int, const double *, const >> double *, const double *, const double *, double *, void *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetRiemannSolver(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:195:75: >> warning: passing argument 7 of ?PetscDSSetJacobianPreconditioner? from >> incompatible pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobianPreconditioner(prob, 0, 0, NULL, NULL, >> NULL, g3_magma_uu);CHKERRQ(ierr); >> >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, >> PetscInt, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:196:69: >> warning: passing argument 6 of ?PetscDSSetJacobianPreconditioner? from >> incompatible pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobianPreconditioner(prob, 0, 1, NULL, NULL, >> g2_stokes_up, NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, >> PetscInt, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:197:63: >> warning: passing argument 5 of ?PetscDSSetJacobianPreconditioner? from >> incompatible pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobianPreconditioner(prob, 1, 0, NULL, >> g1_stokes_pu, NULL, NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, >> PetscInt, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:198:57: >> warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from >> incompatible pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, >> NULL, NULL, g3_magma_pp);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, >> PetscInt, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:198:84: >> warning: passing argument 7 of ?PetscDSSetJacobianPreconditioner? from >> incompatible pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, >> NULL, NULL, g3_magma_pp);CHKERRQ(ierr); >> >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, >> PetscInt, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:199:57: >> warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from >> incompatible pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobianPreconditioner(prob, 2, 2, g0_stokes_phi, >> NULL, NULL, NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, >> PetscInt, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:214:40: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, >> f1_vector_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:214:56: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, >> f1_vector_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:215:40: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_scalar_zero, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:215:56: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_scalar_zero, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:216:40: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 2, f0_advection, >> f1_advection);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:216:56: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 2, f0_advection, >> f1_advection);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:217:45: >> warning: passing argument 3 of ?PetscDSSetRiemannSolver? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetRiemannSolver(prob, 2, >> riemann_coupled_advection);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:213:29: note: expected >> ?void (*)(PetscInt, PetscInt, const PetscReal *, const PetscReal *, const >> PetscScalar *, const PetscScalar *, PetscInt, const PetscScalar *, >> PetscScalar *, void *) {aka void (*)(int, int, const double *, const >> double *, const double *, const double *, int, const double *, double *, >> void *)}? but argument is of type ?void (*)(PetscInt, PetscInt, const >> PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, >> PetscScalar *, void *) {aka void (*)(int, int, const double *, const >> double *, const double *, const double *, double *, void *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetRiemannSolver(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:226:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_stokes_periodic_u, >> f1_stokes_u);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:226:64: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_stokes_periodic_u, >> f1_stokes_u);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:228:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_stokes_u, >> f1_stokes_u);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:228:64: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_stokes_u, >> f1_stokes_u);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:230:40: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_stokes_p, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:230:53: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_stokes_p, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:231:40: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 2, f0_porosity, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:231:53: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 2, f0_porosity, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:232:61: >> warning: passing argument 7 of ?PetscDSSetJacobian? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobian(prob, 0, 0, NULL, NULL, NULL, >> g3_stokes_uu);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, >> PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:233:55: >> warning: passing argument 6 of ?PetscDSSetJacobian? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobian(prob, 0, 1, NULL, NULL, g2_stokes_up, >> NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, >> PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:234:49: >> warning: passing argument 5 of ?PetscDSSetJacobian? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobian(prob, 1, 0, NULL, g1_stokes_pu, NULL, >> NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, >> PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:235:43: >> warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobian(prob, 2, 2, g0_stokes_phi, NULL, NULL, >> NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, >> PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:236:75: >> warning: passing argument 7 of ?PetscDSSetJacobianPreconditioner? from >> incompatible pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobianPreconditioner(prob, 0, 0, NULL, NULL, >> NULL, g3_stokes_uu);CHKERRQ(ierr); >> >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, >> PetscInt, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:237:57: >> warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from >> incompatible pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, >> NULL, NULL, NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, >> PetscInt, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:238:57: >> warning: passing argument 4 of ?PetscDSSetJacobianPreconditioner? from >> incompatible pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobianPreconditioner(prob, 2, 2, g0_stokes_phi, >> NULL, NULL, NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:159:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPreconditioner(PetscDS, >> PetscInt, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:261:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_lap_periodic_u, >> f1_lap_u);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:261:64: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_lap_periodic_u, >> f1_lap_u);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:262:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:262:64: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:265:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_lap_u, >> f1_lap_u);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:265:55: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_lap_u, >> f1_lap_u);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:266:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_pressure, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:266:55: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_pressure, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:269:40: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 2, f0_porosity, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:269:53: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 2, f0_porosity, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:270:61: >> warning: passing argument 7 of ?PetscDSSetJacobian? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobian(prob, 0, 0, NULL, NULL, NULL, >> g3_uu);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, >> PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:271:43: >> warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobian(prob, 1, 1, g0_pressure, NULL, NULL, >> NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, >> PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:272:43: >> warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobian(prob, 2, 2, g0_pressure, NULL, NULL, >> NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, >> PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:294:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_doubly_periodic_velocity, >> f1_vector_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:294:71: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_doubly_periodic_velocity, >> f1_vector_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:295:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_doubly_periodic_pressure, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:295:71: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_doubly_periodic_pressure, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:297:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_periodic_velocity, >> f1_vector_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:297:64: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_periodic_velocity, >> f1_vector_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:298:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:298:64: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:300:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_velocity, >> f1_vector_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:300:55: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 0, f0_velocity, >> f1_vector_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:301:42: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_pressure, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:301:55: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 1, f0_pressure, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:303:40: >> warning: passing argument 3 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 2, f0_porosity, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:303:53: >> warning: passing argument 4 of ?PetscDSSetResidual? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetResidual(prob, 2, f0_porosity, >> f1_scalar_zero);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:97:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:304:43: >> warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobian(prob, 0, 0, g0_velocity, NULL, NULL, >> NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, >> PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:305:43: >> warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobian(prob, 1, 1, g0_pressure, NULL, NULL, >> NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, >> PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:306:43: >> warning: passing argument 4 of ?PetscDSSetJacobian? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetJacobian(prob, 2, 2, g0_pressure, NULL, NULL, >> NULL);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:124:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, PetscReal, const PetscReal *, PetscInt, >> const PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const >> int *, const int *, const double *, const double *, const double *, const >> int *, const int *, const double *, const double *, const double *, >> double, double, const double *, int, const double *, double *)}? but >> argument is of type ?void (*)(PetscInt, PetscInt, PetscInt, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, PetscReal, PetscReal, const >> PetscReal *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, >> double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, >> PetscInt, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function >> ?BenchmarkMonitor?: >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:38: error: >> incompatible type for argument 2 of ?DMProjectField? >> ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, >> C);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/in >> clude/petscsnes.h:6:0, >> from /home/dockimble/PETSc/petsc/include/petscts.h:7, >> from /home/dockimble/PETSc/petsc/include/petsc.h:26, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected >> ?PetscReal {aka double}? but argument is of type ?Vec {aka struct _p_Vec *}? >> PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:41: >> warning: passing argument 3 of ?DMProjectField? from incompatible pointer >> type [-Wincompatible-pointer-types] >> ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, >> C);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/in >> clude/petscsnes.h:6:0, >> from /home/dockimble/PETSc/petsc/include/petscts.h:7, >> from /home/dockimble/PETSc/petsc/include/petsc.h:26, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected >> ?Vec {aka struct _p_Vec *}? but argument is of type ?void (**)(PetscInt, >> PetscInt, PetscInt, const PetscInt *, const PetscInt *, const PetscScalar >> *, const PetscScalar *, const PetscScalar *, const PetscInt *, const >> PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, >> PetscReal, const PetscReal *, PetscScalar *) {aka void (**)(int, int, >> int, const int *, const int *, const double *, const double *, const >> double *, const int *, const int *, const double *, const double *, const >> double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:48: >> warning: passing argument 4 of ?DMProjectField? makes pointer from integer >> without a cast [-Wint-conversion] >> ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, >> C);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/in >> clude/petscsnes.h:6:0, >> from /home/dockimble/PETSc/petsc/include/petscts.h:7, >> from /home/dockimble/PETSc/petsc/include/petsc.h:26, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected >> ?void (**)(PetscInt, PetscInt, PetscInt, const PetscInt *, const >> PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, >> const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar >> *, const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (**)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?int? >> PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:63: error: >> incompatible type for argument 5 of ?DMProjectField? >> ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, >> C);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/in >> clude/petscsnes.h:6:0, >> from /home/dockimble/PETSc/petsc/include/petscts.h:7, >> from /home/dockimble/PETSc/petsc/include/petsc.h:26, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: expected >> ?InsertMode {aka enum }? but argument is of type ?Vec {aka >> struct _p_Vec *}? >> PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:14: error: >> too few arguments to function ?DMProjectField? >> ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, >> C);CHKERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/in >> clude/petscsnes.h:6:0, >> from /home/dockimble/PETSc/petsc/include/petscts.h:7, >> from /home/dockimble/PETSc/petsc/include/petsc.h:26, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: declared >> here >> PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec, >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function >> ?CreateErrorFE?: >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:841:54: error: >> incompatible type for argument 5 of ?PetscDTGaussTensorQuadrature? >> ierr = PetscDTGaussTensorQuadrature(dim,2,-1.0,1.0,&quad);CHKERRQ(i >> err); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, >> from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, >> from /home/dockimble/PETSc/petsc/include/petsc.h:12, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscdt.h:34:29: note: expected >> ?PetscReal {aka double}? but argument is of type ?struct _p_PetscQuadrature >> **? >> PETSC_EXTERN PetscErrorCode PetscDTGaussTensorQuadrature(P >> etscInt,PetscInt,PetscInt,PetscReal,PetscReal,PetscQuadrature*); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:841:10: error: >> too few arguments to function ?PetscDTGaussTensorQuadrature? >> ierr = PetscDTGaussTensorQuadrature(dim,2,-1.0,1.0,&quad);CHKERRQ(i >> err); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, >> from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, >> from /home/dockimble/PETSc/petsc/include/petsc.h:12, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscdt.h:34:29: note: declared here >> PETSC_EXTERN PetscErrorCode PetscDTGaussTensorQuadrature(P >> etscInt,PetscInt,PetscInt,PetscReal,PetscReal,PetscQuadrature*); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function >> ?AdaptPorosityExact?: >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:970:49: error: >> ?DM_FOREST_REFINE? undeclared (first use in this function) >> ierr = DMLabelSetDefaultValue(refineL >> abel,DM_FOREST_REFINE);CHKERRQ(ierr); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:970:49: note: >> each undeclared identifier is reported only once for each function it >> appears in >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:971:14: >> warning: implicit declaration of function ?DMForestAdaptLabel? >> [-Wimplicit-function-declaration] >> ierr = DMForestAdaptLabel(dm,"adapt",&adaptedDM);CHKERRQ(ierr); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:988:46: error: >> ?DM_FOREST_KEEP? undeclared (first use in this function) >> ierr = DMLabelSetDefaultValue(adaptLabel,DM_FOREST_KEEP);CHKERRQ( >> ierr); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:995:45: error: >> ?DM_FOREST_COARSEN? undeclared (first use in this function) >> ierr = DMLabelSetValue(adaptLabel,i,D >> M_FOREST_COARSEN);CHKERRQ(ierr); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function >> ?AdaptPorosityGradient?: >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1151:51: >> warning: passing argument 4 of ?PetscQuadratureGetData? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscQuadratureGetData(q,&dim,&nPoints,&points,&weights);CHK >> ERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, >> from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, >> from /home/dockimble/PETSc/petsc/include/petsc.h:12, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscdt.h:24:29: note: expected >> ?PetscInt * {aka int *}? but argument is of type ?const PetscReal ** {aka >> const double **}? >> PETSC_EXTERN PetscErrorCode PetscQuadratureGetData(PetscQuadrature, >> PetscInt*, PetscInt*, PetscInt*, const PetscReal *[], const PetscReal *[]); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1151:12: >> error: too few arguments to function ?PetscQuadratureGetData? >> ierr = PetscQuadratureGetData(q,&dim,&nPoints,&points,&weights);CHK >> ERRQ(ierr); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0, >> from /home/dockimble/PETSc/petsc/include/petscdmda.h:8, >> from /home/dockimble/PETSc/petsc/include/petsc.h:12, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscdt.h:24:29: note: declared here >> PETSC_EXTERN PetscErrorCode PetscQuadratureGetData(PetscQuadrature, >> PetscInt*, PetscInt*, PetscInt*, const PetscReal *[], const PetscReal *[]); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1250:49: >> error: ?DM_FOREST_REFINE? undeclared (first use in this function) >> ierr = DMLabelSetDefaultValue(refineL >> abel,DM_FOREST_REFINE);CHKERRQ(ierr); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1269:46: >> error: ?DM_FOREST_KEEP? undeclared (first use in this function) >> ierr = DMLabelSetDefaultValue(adaptLabel,DM_FOREST_KEEP);CHKERRQ( >> ierr); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1283:47: >> error: ?DM_FOREST_COARSEN? undeclared (first use in this function) >> ierr = DMLabelSetValue(adaptLabel,i,D >> M_FOREST_COARSEN);CHKERRQ(ierr); >> ^ >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function >> ?main?: >> /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1592:43: >> warning: passing argument 3 of ?PetscDSSetObjective? from incompatible >> pointer type [-Wincompatible-pointer-types] >> ierr = PetscDSSetObjective(prob, 2, compactionRateError);CHKERRQ(i >> err); >> ^ >> In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0, >> from /home/dockimble/PETSc/magma-dy >> namics-problems/src/magma.c:4: >> /home/dockimble/PETSc/petsc/include/petscds.h:83:29: note: expected >> ?void (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt >> *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscInt, const >> PetscScalar *, PetscScalar *) {aka void (*)(int, int, int, const int *, >> const int *, const double *, const double *, const double *, const int *, >> const int *, const double *, const double *, const double *, double, const >> double *, int, const double *, double *)}? but argument is of type ?void >> (*)(PetscInt, PetscInt, PetscInt, const PetscInt *, const PetscInt *, >> const PetscScalar *, const PetscScalar *, const PetscScalar *, const >> PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, >> const PetscScalar *, PetscReal, const PetscReal *, PetscScalar *) {aka >> void (*)(int, int, int, const int *, const int *, const double *, const >> double *, const double *, const int *, const int *, const double *, const >> double *, const double *, double, const double *, double *)}? >> PETSC_EXTERN PetscErrorCode PetscDSSetObjective(PetscDS, PetscInt, >> ^ >> /home/dockimble/PETSc/petsc/lib/petsc/conf/rules:401: recipe for target >> 'magma.o' failed >> make: *** [magma.o] Error 1 >> >> >> Robert L. Walker >> MS Petroleum Engineering >> Mork Family Department of Chemicals and Materials Sciences >> University of Southern California >> ---------------------------------------------- >> Mobile US: +1 (213) - 290 -7101 <(213)%20290-7101> >> Mobile EU: +34 62 274 66 40 >> rlwalker at usc.edu >> > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ > > -------------- next part -------------- An HTML attachment was scrubbed... URL: From jed at jedbrown.org Sun Jul 23 15:51:37 2017 From: jed at jedbrown.org (Jed Brown) Date: Sun, 23 Jul 2017 14:51:37 -0600 Subject: [petsc-users] AGU Session: DI001: Advances in Computational Geosciences Message-ID: <87tw22zxk6.fsf@jedbrown.org> If you are thinking about attending the American Geophysical Union Fall Meeting (Dec 11-15 in New Orleans), please consider submitting an abstract to this diverse session. Abstracts are due August 2. DI001: Advances in Computational Geosciences This session highlights advances in the theory and practice of computational geoscience, from improvements in numerical methods to their application to outstanding problems in the Earth sciences. Common issues include robust and efficient solvers, multiscale discretizations, design of benchmark problems and standards for comparison. Increasing data and computational power necessitates open source scientific libraries and workflow automation for model setup, 3D feature connectivity, and data assimilation, and automation in uncertainty representation and propagation, optimal design of field studies, risk quantification, and testing the predictive power of numerical simulations. By bringing these crosscutting computational activities together in one session, we hope to sharpen our collective understanding of fundamental challenges, level of rigor, and opportunities for reusable implementations. Contributions from all areas are welcome, including, but not limited to, fault modeling, tectonics, subduction, seismology, magma dynamics, mantle convection, the core, as well as surface processes, hydrology, and cryosphere. Conveners: Juliane Dannberg, Marc Spiegelman, and Jed Brown https://agu.confex.com/agu/fm17/preliminaryview.cgi/Session26637 -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From lirui319 at hnu.edu.cn Sun Jul 23 21:30:51 2017 From: lirui319 at hnu.edu.cn (=?GBK?B?wO7I8A==?=) Date: Mon, 24 Jul 2017 10:30:51 +0800 (GMT+08:00) Subject: [petsc-users] Lowly convergenced rate of GMRES Message-ID: <19205a1.f42a.15d726ed2f2.Coremail.lirui319@hnu.edu.cn> Dear professor or engineer: I use GMRES method to solve a linear Non-Hermite equation.To improve the convergenced rate of GMRES method in limited steps,I have tried serval ways i can do.My makefile is written such following content: >>... >> -ksp_monitor -ksp_max_it 500 \ksp_type gmres \ >> -ksp_gmres_restart 90 -ksp_atol 1.e-6 \ >> -ksp_rtol 1.e-9 -ksp_pc_side right \ >> -pc_type asm -pc_asm_type restrict -pc_asm_overlap 2 \ >> -sub_ksp_type preonly -sub_pc_type lu The result is always not pleasure. 1 KSP Residual norm 4.436461190051e+04 2 KSP Residual norm 9.773182866331e+03 3 KSP Residual norm 8.432841532618e+03 4 KSP Residual norm 7.642491240521e+03 ...... 497 KSP Residual norm 5.345439499920e+02 498 KSP Residual norm 5.269741944074e+02 499 KSP Residual norm 5.197171806884e+02 500 KSP Residual norm 5.127519507363e+02 Could you provide some ideas to increase the convergenced rate of this type of method?Thanks? From bsmith at mcs.anl.gov Sun Jul 23 21:31:06 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 23 Jul 2017 21:31:06 -0500 Subject: [petsc-users] Lowly convergenced rate of GMRES In-Reply-To: <19205a1.f42a.15d726ed2f2.Coremail.lirui319@hnu.edu.cn> References: <19205a1.f42a.15d726ed2f2.Coremail.lirui319@hnu.edu.cn> Message-ID: <7F18BEFD-FE9F-4C43-8E49-D9124BD2D69C@mcs.anl.gov> Where is the matrix coming from, what discretization are you using and how large is it? Preconditioning is very dependent on the matrix in question, for example some systems arising from the Helmholtz equation are extremely difficult to precondition and often direct solvers are the best approach. Barry > On Jul 23, 2017, at 9:30 PM, ?? wrote: > > Dear professor or engineer: > I use GMRES method to solve a linear Non-Hermite equation.To improve the convergenced rate of GMRES method in limited steps,I have tried serval ways i can do.My makefile is written such following content: > >>> ... >>> -ksp_monitor -ksp_max_it 500 \ksp_type gmres \ >>> -ksp_gmres_restart 90 -ksp_atol 1.e-6 \ >>> -ksp_rtol 1.e-9 -ksp_pc_side right \ >>> -pc_type asm -pc_asm_type restrict -pc_asm_overlap 2 \ >>> -sub_ksp_type preonly -sub_pc_type lu > > The result is always not pleasure. > 1 KSP Residual norm 4.436461190051e+04 > 2 KSP Residual norm 9.773182866331e+03 > 3 KSP Residual norm 8.432841532618e+03 > 4 KSP Residual norm 7.642491240521e+03 > ...... > 497 KSP Residual norm 5.345439499920e+02 > 498 KSP Residual norm 5.269741944074e+02 > 499 KSP Residual norm 5.197171806884e+02 > 500 KSP Residual norm 5.127519507363e+02 > > Could you provide some ideas to increase the convergenced rate of this type of method?Thanks? > From niko.karin at gmail.com Wed Jul 26 07:56:32 2017 From: niko.karin at gmail.com (Karin&NiKo) Date: Wed, 26 Jul 2017 14:56:32 +0200 Subject: [petsc-users] PCASM and restriction operators Message-ID: Dear PETSc team, I would like to understand the ASM implemented in PETSc. In order to build the link between the theory and the implementation, I would like to know if it is possible to print or export the restriction and prolongation operators. I have seen in the code (asm.c) that they are VecScatter objects and I wonder if their is a way to visualize them. Thanks in advance, Nicolas -------------- next part -------------- An HTML attachment was scrubbed... URL: From assameen at esxhange.com Wed Jul 26 10:54:49 2017 From: assameen at esxhange.com (Gerry Arnold) Date: 26 Jul 2017 11:54:49 -0400 Subject: [petsc-users] Company News: New Scheduling System Message-ID: I am looking for further information. Are you the right person to contact? Gerry Arnold VP of Operations Arnold Inc. 323-674-2900 From jed at jedbrown.org Wed Jul 26 11:17:04 2017 From: jed at jedbrown.org (Jed Brown) Date: Wed, 26 Jul 2017 10:17:04 -0600 Subject: [petsc-users] PCASM and restriction operators In-Reply-To: References: Message-ID: <87r2x3jhq7.fsf@jedbrown.org> They are your subdomains, plus some number of levels of overlap (1 by default). You can call PCASMGetLocalSubdomains which gives you ISs for the subdomain, then use it to insert ones into a zeroed global vector. Plotting that will give you the characteristic function of the subdomain which you can visualize using whatever tools you like. Karin&NiKo writes: > Dear PETSc team, > > I would like to understand the ASM implemented in PETSc. In order to build > the link between the theory and the implementation, I would like to know if > it is possible to print or export the restriction and prolongation > operators. I have seen in the code (asm.c) that they are VecScatter objects > and I wonder if their is a way to visualize them. > > Thanks in advance, > Nicolas -------------- next part -------------- A non-text attachment was scrubbed... Name: signature.asc Type: application/pgp-signature Size: 832 bytes Desc: not available URL: From d.scott at epcc.ed.ac.uk Thu Jul 27 09:05:47 2017 From: d.scott at epcc.ed.ac.uk (David Scott) Date: Thu, 27 Jul 2017 15:05:47 +0100 Subject: [petsc-users] Obtaining an Operator Message-ID: <5e639ec7-f3b4-3882-8adf-b8143828e710@epcc.ed.ac.uk> Hello, In my code I have call KSPSetComputeOperators(ksp_u, compute_matrix_u, PETSC_NULL_OBJECT, ierr) later I have something like call KSPSolve(ksp_u, RHS_u_vec, u3_vec, ierr) call DMCreateMatrix(da_u, B, ierr) call compute_matrix_u(ksp_u, B, B, PETSC_NULL_INTEGER, ierr) call KSPGetOperators(ksp_u, A, PETSC_NULL_OBJECT, ierr) call MatEqual(A, B, flg, ierr) inside a loop. On the first iteration 'flg' is set to PETSC_TRUE but after that it is set to PETSC_FALSE. Why is that? My code includes a hand-crafted iterative solver and I want to be able to evaluate the residual norm of the aproximate solution it produces using the matrix of an analogous PETSc solver. I am trying to determine the best way to obtain this matrix. In this case KSPSolve will not have been called and I want to know if I can obtain it using compute_matrix_u. David -- The University of Edinburgh is a charitable body, registered in Scotland, with registration number SC005336. From bsmith at mcs.anl.gov Thu Jul 27 12:14:31 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Thu, 27 Jul 2017 12:14:31 -0500 Subject: [petsc-users] Obtaining an Operator In-Reply-To: <5e639ec7-f3b4-3882-8adf-b8143828e710@epcc.ed.ac.uk> References: <5e639ec7-f3b4-3882-8adf-b8143828e710@epcc.ed.ac.uk> Message-ID: <2D89337C-3ECF-4201-B0E8-3980E74BB1E3@mcs.anl.gov> From the manual page: Notes: The user provided func() will be called automatically at the very next call to KSPSolve(). It will not be called at future KSPSolve() calls unless either KSPSetComputeOperators() or KSPSetOperators() is called before that KSPSolve() is called. So you need to put something like KSPSetOperators() immediately before the call to KSPSolve within your loop > On Jul 27, 2017, at 9:05 AM, David Scott wrote: > > Hello, > > In my code I have > > call KSPSetComputeOperators(ksp_u, compute_matrix_u, PETSC_NULL_OBJECT, ierr) > > later I have something like > > call KSPSolve(ksp_u, RHS_u_vec, u3_vec, ierr) > call DMCreateMatrix(da_u, B, ierr) > call compute_matrix_u(ksp_u, B, B, PETSC_NULL_INTEGER, ierr) > call KSPGetOperators(ksp_u, A, PETSC_NULL_OBJECT, ierr) > call MatEqual(A, B, flg, ierr) > > inside a loop. > > On the first iteration 'flg' is set to PETSC_TRUE but after that it is set to PETSC_FALSE. Why is that? > > My code includes a hand-crafted iterative solver and I want to be able to evaluate the residual norm of the aproximate solution it produces using the matrix of an analogous PETSc solver. I am trying to determine the best way to obtain this matrix. In this case KSPSolve will not have been called and I want to know if I can obtain it using compute_matrix_u. > > David > > -- > The University of Edinburgh is a charitable body, registered in > Scotland, with registration number SC005336. > From snorris at smu.edu Fri Jul 28 14:13:27 2017 From: snorris at smu.edu (Scott Norris) Date: Fri, 28 Jul 2017 14:13:27 -0500 Subject: [petsc-users] Questions from a new user Message-ID: Hi, My graduate student and I are new to petsc -- we have worked through some of the PDE examples, and modified them to use solve a single-variable nonlinear PDE relevant to our research, by defining appropriate callback functions (i.e. problem definition, jacobian of residual, and initial condition). Although we are not numerical specialists, this seemed relatively straightforward, and we are very much appreciative! Now we are looking to use it to solve a system of linear boundary-value problems. This seems like it ought to be broadly similar in structure despite the lack of timestepping (i.e. one still needs a problem definition, residual jacobian, and initial guess), with the main complication being the addition of multiple fields/components. We've found simple examples where a single linear BVP is solved directly using KSP (which we've been able to run and modify successfully), but this seems rather low-level, and we've found no KSP examples that involved multple variables, and manually keeping track of which blocks of a vector / matrix correspond to which variable seems a bit of a headache. In contrast, we've found examples with multiple components, including one (ex19.c) with nice notation such as f[j][i].u = f[j][i].v = However, this seems much more complicated than our case, and we are struggling to understand it (i.e., the the NonlinearGS-related code optional?) For someone who approaches this very much as an end-user (i.e. quick solution to BVPs/PDEs on simple grids), I'm thinking a simple nonlinear system example is likely to be the way to go -- it would resemble the PDEs we've already solved, work for nonlinear problems if we get to them, and in the event that our equations are actually linear, then the Jacobian would simply be the matrix one creates in a simple KSP example (which, as an added bonus, could be approximated). Okay, to our questions: (1) Does this seem reasonable? Are we missing an important sense of the overall structure of PETSc? (2) Can multi-variable BVPs be solved in a user-friendly way (a.u, a.v, etc.) using the linear solvers? (3) If the nonlinear solvers allow a more user-friendly interface, are there any special considerations to keep in mind? (4) Most generally, where else should we look for inspiration? Are there more detailed tutorials than the examples? Thanks in advance for your time and any thoughts. Scott Norris Department of Mathematics Southern Methodist University -- Dr. Scott A. Norris Associate Professor of Mathematics Director of Undergraduate Studies http://faculty.smu.edu/snorris https://smu-snorris.ycb.me Clements Hall, Room 239 -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Fri Jul 28 14:46:09 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Fri, 28 Jul 2017 14:46:09 -0500 Subject: [petsc-users] Questions from a new user In-Reply-To: References: Message-ID: <0E79C4E6-A4FD-4265-9A72-72FDF758F543@mcs.anl.gov> > On Jul 28, 2017, at 2:13 PM, Scott Norris wrote: > > Hi, > > My graduate student and I are new to petsc -- we have worked through some of the PDE examples, and modified them to use solve a single-variable nonlinear PDE relevant to our research, by defining appropriate callback functions (i.e. problem definition, jacobian of residual, and initial condition). Although we are not numerical specialists, this seemed relatively straightforward, and we are very much appreciative! > > Now we are looking to use it to solve a system of linear boundary-value problems. This seems like it ought to be broadly similar in structure despite the lack of timestepping (i.e. one still needs a problem definition, residual jacobian, and initial guess), with the main complication being the addition of multiple fields/components. > > We've found simple examples where a single linear BVP is solved directly using KSP (which we've been able to run and modify successfully), but this seems rather low-level, and we've found no KSP examples that involved multple variables, and manually keeping track of which blocks of a vector / matrix correspond to which variable seems a bit of a headache. In contrast, we've found examples with multiple components, including one (ex19.c) with nice notation such as > f[j][i].u = > f[j][i].v = > However, this seems much more complicated than our case, and we are struggling to understand it (i.e., the the NonlinearGS-related code optional?) You are safe to totally ignore the NonlinearGS code, it is not for regular users (or almost anyone else). > > > For someone who approaches this very much as an end-user (i.e. quick solution to BVPs/PDEs on simple grids), I'm thinking a simple nonlinear system example is likely to be the way to go -- it would resemble the PDEs we've already solved, work for nonlinear problems if we get to them, and in the event that our equations are actually linear, then the Jacobian would simply be the matrix one creates in a simple KSP example (which, as an added bonus, could be approximated). > > Okay, to our questions: > (1) Does this seem reasonable? Are we missing an important sense of the overall structure of PETSc? > (2) Can multi-variable BVPs be solved in a user-friendly way (a.u, a.v, etc.) using the linear solvers? Yes. > (3) If the nonlinear solvers allow a more user-friendly interface, are there any special considerations to keep in mind? > (4) Most generally, where else should we look for inspiration? Are there more detailed tutorials than the examples? Sadly our examples are not as clearly organized as they could be. There are several examples in src/ksp/ksp/examples/tutorials that use finite elements for multi-component problems but no good examples with finite differences. The only good example of multicomponent for finite differences is in src/snes/examples/tutorials/ex19.c but we don't even compute provide code for computing the Jacobian (though that would not be terribly difficult). Take a look also at src/ts/examples/tutorials/advection-diffusion-reaction/ex5.c that does a two component problem with finite differences (time dependent). Barry > > Thanks in advance for your time and any thoughts. > > Scott Norris > Department of Mathematics > Southern Methodist University > > > -- > Dr. Scott A. Norris > Associate Professor of Mathematics > Director of Undergraduate Studies > http://faculty.smu.edu/snorris > https://smu-snorris.ycb.me > Clements Hall, Room 239 > > From olk548 at mail.usask.ca Sat Jul 29 17:06:01 2017 From: olk548 at mail.usask.ca (Oleksandr Koshkarov) Date: Sat, 29 Jul 2017 16:06:01 -0600 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice Message-ID: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> Dear All, I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) \frac{dC_{m,m,p}}{dt} =\\ \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) where a,b,c,d,e,f are some constants which can depend on n,m,p, n,m,p = 0...N, C_{n,m,p} = C_{n,m,p}(x,y,z), E_x = E_x(x,y,z), (same for E_y,B_x,...) and fields are described with equation of the sort (linear pdes with source terms dependent on C): \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x with A,B being some constants. I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) If you have some other suggestions, please feel free to share Thanks and best regards, Oleksandr Koshkarov. From bsmith at mcs.anl.gov Sat Jul 29 18:23:13 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sat, 29 Jul 2017 18:23:13 -0500 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> Message-ID: <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> DMDA provides a simple way to do domain decomposition of structured grid meshes in the x, y, and z direction, that is it makes it easy to efficiently chop up vectors in all 3 dimensions, allowing very large problems easily. Unfortunately it only goes up to 3 dimensions and attempts to produce versions for higher dimensions have failed. If you would like to do domain decomposition across all six of your dimensions (which I think you really need to do to solve large problems) we don't have a tool that helps with doing the domain decomposition. To make matters more complicated, likely the 3d mpi-fftw that need to be applied require rejiggering the data across the nodes to get it into a form where the ffts can be applied efficiently. I don't think there is necessarily anything theoretically difficult about managing the six dimensional domain decomposition I just don't know of any open source software out there that helps to do this. Maybe some PETSc users are aware of such software and can chime in. Aside from these two issues :-) PETSc would be useful for you since you could use our time integrators and nonlinear solvers. Pulling out subvectors to process on can be done with with either VecScatter or VecStrideScatter, VecStrideGather etc depending on the layout of the unknowns, i.e. how the domain decomposition is done. I wish I had better answers for managing the 6d domain decomposition Barry > On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov wrote: > > Dear All, > > I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. > > I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: > > (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) > > \frac{dC_{m,m,p}}{dt} =\\ > \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ > + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ > + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ > + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ > + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) > > > where a,b,c,d,e,f are some constants which can depend on n,m,p, > > n,m,p = 0...N, > > C_{n,m,p} = C_{n,m,p}(x,y,z), > > E_x = E_x(x,y,z), (same for E_y,B_x,...) > > and fields are described with equation of the sort (linear pdes with source terms dependent on C): > > \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ > \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x > > with A,B being some constants. > > I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where > > I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. > > The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? > > Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) > > If you have some other suggestions, please feel free to share > > Thanks and best regards, > > Oleksandr Koshkarov. > From olk548 at mail.usask.ca Sat Jul 29 19:01:24 2017 From: olk548 at mail.usask.ca (Oleksandr Koshkarov) Date: Sat, 29 Jul 2017 18:01:24 -0600 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> Message-ID: <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> Thank you for the response, Now that you said about additional communication for fft, I want to ask another question: What if I disregard FFT and will compute convolution directly, I will rewrite it as vector-matrix-vector product x^T A x (where T - is transpose, x - is my state vector, and A is a matrix which represents convolution and probably it will be not very sparse). Yes - I will do more work (alghorithm will be slower), but will I win if we take the parallelization into account - less communication + probably more scalable algorithm? Best regards, Alex. On 07/29/2017 05:23 PM, Barry Smith wrote: > DMDA provides a simple way to do domain decomposition of structured grid meshes in the x, y, and z direction, that is it makes it easy to efficiently chop up vectors in all 3 dimensions, allowing very large problems easily. Unfortunately it only goes up to 3 dimensions and attempts to produce versions for higher dimensions have failed. > > If you would like to do domain decomposition across all six of your dimensions (which I think you really need to do to solve large problems) we don't have a tool that helps with doing the domain decomposition. To make matters more complicated, likely the 3d mpi-fftw that need to be applied require rejiggering the data across the nodes to get it into a form where the ffts can be applied efficiently. > > I don't think there is necessarily anything theoretically difficult about managing the six dimensional domain decomposition I just don't know of any open source software out there that helps to do this. Maybe some PETSc users are aware of such software and can chime in. > > Aside from these two issues :-) PETSc would be useful for you since you could use our time integrators and nonlinear solvers. Pulling out subvectors to process on can be done with with either VecScatter or VecStrideScatter, VecStrideGather etc depending on the layout of the unknowns, i.e. how the domain decomposition is done. > > I wish I had better answers for managing the 6d domain decomposition > > Barry > > > > >> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov wrote: >> >> Dear All, >> >> I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. >> >> I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: >> >> (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) >> >> \frac{dC_{m,m,p}}{dt} =\\ >> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ >> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ >> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ >> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) >> >> >> where a,b,c,d,e,f are some constants which can depend on n,m,p, >> >> n,m,p = 0...N, >> >> C_{n,m,p} = C_{n,m,p}(x,y,z), >> >> E_x = E_x(x,y,z), (same for E_y,B_x,...) >> >> and fields are described with equation of the sort (linear pdes with source terms dependent on C): >> >> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ >> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >> >> with A,B being some constants. >> >> I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where >> >> I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. >> >> The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? >> >> Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) >> >> If you have some other suggestions, please feel free to share >> >> Thanks and best regards, >> >> Oleksandr Koshkarov. >> From bsmith at mcs.anl.gov Sat Jul 29 20:03:02 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sat, 29 Jul 2017 20:03:02 -0500 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> Message-ID: > On Jul 29, 2017, at 7:01 PM, Oleksandr Koshkarov wrote: > > Thank you for the response, > > Now that you said about additional communication for fft, I want to ask another question: > > What if I disregard FFT and will compute convolution directly, I will rewrite it as vector-matrix-vector product > > x^T A x (where T - is transpose, x - is my state vector, and A is a matrix which represents convolution and probably it will be not very sparse). > > Yes - I will do more work (alghorithm will be slower), but will I win if we take the parallelization into account - less communication + probably more scalable algorithm? This is completely a guess. No you won't win, the FFT is just so amazing not using it will inflate the work so much there is no recovery. > > Best regards, > > Alex. > > > On 07/29/2017 05:23 PM, Barry Smith wrote: >> DMDA provides a simple way to do domain decomposition of structured grid meshes in the x, y, and z direction, that is it makes it easy to efficiently chop up vectors in all 3 dimensions, allowing very large problems easily. Unfortunately it only goes up to 3 dimensions and attempts to produce versions for higher dimensions have failed. >> >> If you would like to do domain decomposition across all six of your dimensions (which I think you really need to do to solve large problems) we don't have a tool that helps with doing the domain decomposition. To make matters more complicated, likely the 3d mpi-fftw that need to be applied require rejiggering the data across the nodes to get it into a form where the ffts can be applied efficiently. >> >> I don't think there is necessarily anything theoretically difficult about managing the six dimensional domain decomposition I just don't know of any open source software out there that helps to do this. Maybe some PETSc users are aware of such software and can chime in. >> >> Aside from these two issues :-) PETSc would be useful for you since you could use our time integrators and nonlinear solvers. Pulling out subvectors to process on can be done with with either VecScatter or VecStrideScatter, VecStrideGather etc depending on the layout of the unknowns, i.e. how the domain decomposition is done. >> >> I wish I had better answers for managing the 6d domain decomposition >> >> Barry >> >> >> >> >>> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov wrote: >>> >>> Dear All, >>> >>> I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. >>> >>> I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: >>> >>> (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) >>> >>> \frac{dC_{m,m,p}}{dt} =\\ >>> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ >>> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ >>> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ >>> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >>> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) >>> >>> >>> where a,b,c,d,e,f are some constants which can depend on n,m,p, >>> >>> n,m,p = 0...N, >>> >>> C_{n,m,p} = C_{n,m,p}(x,y,z), >>> >>> E_x = E_x(x,y,z), (same for E_y,B_x,...) >>> >>> and fields are described with equation of the sort (linear pdes with source terms dependent on C): >>> >>> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ >>> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >>> >>> with A,B being some constants. >>> >>> I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where >>> >>> I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. >>> >>> The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? >>> >>> Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) >>> >>> If you have some other suggestions, please feel free to share >>> >>> Thanks and best regards, >>> >>> Oleksandr Koshkarov. >>> > From knepley at gmail.com Sun Jul 30 10:01:59 2017 From: knepley at gmail.com (Matthew Knepley) Date: Sun, 30 Jul 2017 10:01:59 -0500 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> Message-ID: On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov wrote: > Thank you for the response, > > Now that you said about additional communication for fft, I want to ask > another question: > > What if I disregard FFT and will compute convolution directly, I will > rewrite it as vector-matrix-vector product > I would caution you here. The algorithm is the most important thing to get right up front. In this case, the effect of dimension will be dominant, and anything that does not scale well with dimension will be thrown away, perhaps quite quickly, as you want to solve bigger problems. Small calculation: Take a 6-dim box which is 'n' on a side, so that N = n^6. FFT is N log N, whereas direct evaluation of a convolution is N^2. So if we could do n = 100 points on a side with FFT, you can do, assuming the constants are about equal, 100^6 (log 100^6) = x^12 1e12 (6 2) = x^12 x ~ 10 Past versions of PETSc had a higher dimensional DA construct (adda in prior versions), but no one used it so we removed it. I assume you are proposing something like https://arxiv.org/abs/1306.4625 or maybe https://arxiv.org/abs/1610.00397 The later is interesting since I think you could use a DMDA for the velocity and something like DMPlex for the space. Thanks, Matt > x^T A x (where T - is transpose, x - is my state vector, and A is a matrix > which represents convolution and probably it will be not very sparse). > > Yes - I will do more work (alghorithm will be slower), but will I win if > we take the parallelization into account - less communication + probably > more scalable algorithm? > > Best regards, > > Alex. > > > > On 07/29/2017 05:23 PM, Barry Smith wrote: > >> DMDA provides a simple way to do domain decomposition of structured >> grid meshes in the x, y, and z direction, that is it makes it easy to >> efficiently chop up vectors in all 3 dimensions, allowing very large >> problems easily. Unfortunately it only goes up to 3 dimensions and attempts >> to produce versions for higher dimensions have failed. >> >> If you would like to do domain decomposition across all six of your >> dimensions (which I think you really need to do to solve large problems) we >> don't have a tool that helps with doing the domain decomposition. To make >> matters more complicated, likely the 3d mpi-fftw that need to be applied >> require rejiggering the data across the nodes to get it into a form where >> the ffts can be applied efficiently. >> >> I don't think there is necessarily anything theoretically difficult >> about managing the six dimensional domain decomposition I just don't know >> of any open source software out there that helps to do this. Maybe some >> PETSc users are aware of such software and can chime in. >> >> Aside from these two issues :-) PETSc would be useful for you since >> you could use our time integrators and nonlinear solvers. Pulling out >> subvectors to process on can be done with with either VecScatter or >> VecStrideScatter, VecStrideGather etc depending on the layout of the >> unknowns, i.e. how the domain decomposition is done. >> >> I wish I had better answers for managing the 6d domain decomposition >> >> Barry >> >> >> >> >> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov >>> wrote: >>> >>> Dear All, >>> >>> I am a new PETSc user and I am still in the middle of the manual (I have >>> finally settled to choose PETSc as my main numerical library) so I am sorry >>> beforehand if my questions would be naive. >>> >>> I am trying to solve 6+1 dimensional Vlasov equation with spectral >>> methods. More precisely, I will try to solve half-discretized equations of >>> the form (approximate form) with pseudospectral Fourier method: >>> >>> (Equations are in latex format, the nice website to see them is >>> https://www.codecogs.com/latex/eqneditor.php) >>> >>> \frac{dC_{m,m,p}}{dt} =\\ >>> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} >>> \right ) \\ >>> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} >>> \right ) \\ >>> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} >>> \right ) \\ >>> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >>> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y >>> (\dots) + B_z (\dots) >>> >>> >>> where a,b,c,d,e,f are some constants which can depend on n,m,p, >>> >>> n,m,p = 0...N, >>> >>> C_{n,m,p} = C_{n,m,p}(x,y,z), >>> >>> E_x = E_x(x,y,z), (same for E_y,B_x,...) >>> >>> and fields are described with equation of the sort (linear pdes with >>> source terms dependent on C): >>> >>> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + >>> BC_{0,0,0}) \\ >>> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >>> >>> with A,B being some constants. >>> >>> I will need fully implicit Crank?Nicolson method, so my plan is to use >>> SNES or TS where >>> >>> I will use one MPI PETSc vector which describes the state of the system >>> (all, C, E, B), then I can evolve linear part with just matrix >>> multiplication. >>> >>> The first question is, should I use something like DMDA? if so, it is >>> only 3dimensional but I need 6 dimensional vectots? Will it be faster then >>> matrix multiplication? >>> >>> Then to do nonlinear part I will need 3d mpi-fftw to compute >>> convolutions. The problem is, how do I extract subvectors from full big >>> vector state? (what is the best approach?) >>> >>> If you have some other suggestions, please feel free to share >>> >>> Thanks and best regards, >>> >>> Oleksandr Koshkarov. >>> >>> > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From olk548 at mail.usask.ca Sun Jul 30 12:44:22 2017 From: olk548 at mail.usask.ca (Oleksandr Koshkarov) Date: Sun, 30 Jul 2017 11:44:22 -0600 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> Message-ID: <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> Thanks for the references, and warning. I am trying to do exactly this http://www.sciencedirect.com/science/article/pii/S0021999115004738 (I probably should have added the reference in the first place, sorry) the evolution formula is (15) in the article. So, I will do convolution only in 3D (while full system is 6D) because velocity space is not discretized with Fourier So As I understand, it will not be N^2 vs N logN. Moreover, I know that algorithm with FFT has significantly larger "constant". Please correct me if I am wrong here :) I know for sure that FFT is a must at the end, but I thought I can start with matrix product to get more familiar with PETSc as it will be simpler to implement (At least I think so). I hope it does make sense. Another question about convolution via matrix product. Is there better way to do it other then to construct NxN Toeplitz-like matrix each time step on the "fly" from state vector and then multiply it to state vector? p.s. Probably I should do FFT from the start, but I am a little bit intimidated by the problem taking into account that I do not have PETSc experience. Best regards, Oleksandr Koshkarov. On 07/30/2017 09:01 AM, Matthew Knepley wrote: > On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov > > wrote: > > Thank you for the response, > > Now that you said about additional communication for fft, I want > to ask another question: > > What if I disregard FFT and will compute convolution directly, I > will rewrite it as vector-matrix-vector product > > > I would caution you here. The algorithm is the most important thing > to get right up front. In this case, the effect of > dimension will be dominant, and anything that does not scale well with > dimension will be thrown away, perhaps > quite quickly, as you want to solve bigger problems. > > Small calculation: Take a 6-dim box which is 'n' on a side, so that N > = n^6. FFT is N log N, whereas direct evaluation of > a convolution is N^2. So if we could do n = 100 points on a side with > FFT, you can do, assuming the constants are about > equal, > > 100^6 (log 100^6) = x^12 > 1e12 (6 2) = x^12 > x ~ 10 > > Past versions of PETSc had a higher dimensional DA construct (adda in > prior versions), but no one used it so we removed it. > > I assume you are proposing something like > > https://arxiv.org/abs/1306.4625 > > or maybe > > https://arxiv.org/abs/1610.00397 > > The later is interesting since I think you could use a DMDA for the > velocity and something like DMPlex for the space. > > Thanks, > > Matt > > x^T A x (where T - is transpose, x - is my state vector, and A is > a matrix which represents convolution and probably it will be not > very sparse). > > Yes - I will do more work (alghorithm will be slower), but will I > win if we take the parallelization into account - less > communication + probably more scalable algorithm? > > Best regards, > > Alex. > > > > On 07/29/2017 05:23 PM, Barry Smith wrote: > > DMDA provides a simple way to do domain decomposition of > structured grid meshes in the x, y, and z direction, that is > it makes it easy to efficiently chop up vectors in all 3 > dimensions, allowing very large problems easily. Unfortunately > it only goes up to 3 dimensions and attempts to produce > versions for higher dimensions have failed. > > If you would like to do domain decomposition across all six > of your dimensions (which I think you really need to do to > solve large problems) we don't have a tool that helps with > doing the domain decomposition. To make matters more > complicated, likely the 3d mpi-fftw that need to be applied > require rejiggering the data across the nodes to get it into a > form where the ffts can be applied efficiently. > > I don't think there is necessarily anything theoretically > difficult about managing the six dimensional domain > decomposition I just don't know of any open source software > out there that helps to do this. Maybe some PETSc users are > aware of such software and can chime in. > > Aside from these two issues :-) PETSc would be useful for > you since you could use our time integrators and nonlinear > solvers. Pulling out subvectors to process on can be done with > with either VecScatter or VecStrideScatter, VecStrideGather > etc depending on the layout of the unknowns, i.e. how the > domain decomposition is done. > > I wish I had better answers for managing the 6d domain > decomposition > > Barry > > > > > On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov > > wrote: > > Dear All, > > I am a new PETSc user and I am still in the middle of the > manual (I have finally settled to choose PETSc as my main > numerical library) so I am sorry beforehand if my > questions would be naive. > > I am trying to solve 6+1 dimensional Vlasov equation with > spectral methods. More precisely, I will try to solve > half-discretized equations of the form (approximate form) > with pseudospectral Fourier method: > > (Equations are in latex format, the nice website to see > them is https://www.codecogs.com/latex/eqneditor.php > ) > > \frac{dC_{m,m,p}}{dt} =\\ > \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n > C_{n-1,m,p} \right ) \\ > + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m > C_{n,m-1,p} \right ) \\ > + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p > C_{n,m,p-1} \right ) \\ > + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x > C_{n,m,p-1} \\ > + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + > \dots) + B_y (\dots) + B_z (\dots) > > > where a,b,c,d,e,f are some constants which can depend on > n,m,p, > > n,m,p = 0...N, > > C_{n,m,p} = C_{n,m,p}(x,y,z), > > E_x = E_x(x,y,z), (same for E_y,B_x,...) > > and fields are described with equation of the sort (linear > pdes with source terms dependent on C): > > \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + > (AC_{1,0,0} + BC_{0,0,0}) \\ > \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x > > with A,B being some constants. > > I will need fully implicit Crank?Nicolson method, so my > plan is to use SNES or TS where > > I will use one MPI PETSc vector which describes the state > of the system (all, C, E, B), then I can evolve linear > part with just matrix multiplication. > > The first question is, should I use something like DMDA? > if so, it is only 3dimensional but I need 6 dimensional > vectots? Will it be faster then matrix multiplication? > > Then to do nonlinear part I will need 3d mpi-fftw to > compute convolutions. The problem is, how do I extract > subvectors from full big vector state? (what is the best > approach?) > > If you have some other suggestions, please feel free to share > > Thanks and best regards, > > Oleksandr Koshkarov. > > > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which > their experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From knepley at gmail.com Sun Jul 30 13:46:37 2017 From: knepley at gmail.com (Matthew Knepley) Date: Sun, 30 Jul 2017 13:46:37 -0500 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> Message-ID: On Sun, Jul 30, 2017 at 12:44 PM, Oleksandr Koshkarov wrote: > Thanks for the references, and warning. > > I am trying to do exactly this > > http://www.sciencedirect.com/science/article/pii/S0021999115004738 > > (I probably should have added the reference in the first place, sorry) > > the evolution formula is (15) in the article. > > So, I will do convolution only in 3D (while full system is 6D) because > velocity space is not discretized with Fourier > > So As I understand, it will not be N^2 vs N logN. Moreover, I know that > algorithm with FFT has significantly larger "constant". > > Please correct me if I am wrong here :) > > I think you are wrong here. First, I do not understand why you think the asymptotics have changed. Second, the constant for FFT is about 6, which would be really hard to beat with a quadrature. Last, this discretization looks fully coupled to me. I cannot see how you would parallelize this right off the bat. This is a problem with spectral discretizations, and the main motivator for spectral elements. Thanks, Matt > I know for sure that FFT is a must at the end, but I thought I can start > with matrix product to get more familiar with PETSc as it will be simpler > to implement (At least I think so). > > I hope it does make sense. > > Another question about convolution via matrix product. Is there better way > to do it other then to construct NxN Toeplitz-like matrix each time step on > the "fly" from state vector and then multiply it to state vector? > > p.s. Probably I should do FFT from the start, but I am a little bit > intimidated by the problem taking into account that I do not have PETSc > experience. > Best regards, > Oleksandr Koshkarov. > > On 07/30/2017 09:01 AM, Matthew Knepley wrote: > > On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov > wrote: > >> Thank you for the response, >> >> Now that you said about additional communication for fft, I want to ask >> another question: >> >> What if I disregard FFT and will compute convolution directly, I will >> rewrite it as vector-matrix-vector product >> > > I would caution you here. The algorithm is the most important thing to > get right up front. In this case, the effect of > dimension will be dominant, and anything that does not scale well with > dimension will be thrown away, perhaps > quite quickly, as you want to solve bigger problems. > > Small calculation: Take a 6-dim box which is 'n' on a side, so that N = > n^6. FFT is N log N, whereas direct evaluation of > a convolution is N^2. So if we could do n = 100 points on a side with FFT, > you can do, assuming the constants are about > equal, > > 100^6 (log 100^6) = x^12 > 1e12 (6 2) = x^12 > x ~ 10 > > Past versions of PETSc had a higher dimensional DA construct (adda in > prior versions), but no one used it so we removed it. > > I assume you are proposing something like > > https://arxiv.org/abs/1306.4625 > > or maybe > > https://arxiv.org/abs/1610.00397 > > The later is interesting since I think you could use a DMDA for the > velocity and something like DMPlex for the space. > > Thanks, > > Matt > > >> x^T A x (where T - is transpose, x - is my state vector, and A is a >> matrix which represents convolution and probably it will be not very >> sparse). >> >> Yes - I will do more work (alghorithm will be slower), but will I win if >> we take the parallelization into account - less communication + probably >> more scalable algorithm? >> >> Best regards, >> >> Alex. >> >> >> >> On 07/29/2017 05:23 PM, Barry Smith wrote: >> >>> DMDA provides a simple way to do domain decomposition of structured >>> grid meshes in the x, y, and z direction, that is it makes it easy to >>> efficiently chop up vectors in all 3 dimensions, allowing very large >>> problems easily. Unfortunately it only goes up to 3 dimensions and attempts >>> to produce versions for higher dimensions have failed. >>> >>> If you would like to do domain decomposition across all six of your >>> dimensions (which I think you really need to do to solve large problems) we >>> don't have a tool that helps with doing the domain decomposition. To make >>> matters more complicated, likely the 3d mpi-fftw that need to be applied >>> require rejiggering the data across the nodes to get it into a form where >>> the ffts can be applied efficiently. >>> >>> I don't think there is necessarily anything theoretically difficult >>> about managing the six dimensional domain decomposition I just don't know >>> of any open source software out there that helps to do this. Maybe some >>> PETSc users are aware of such software and can chime in. >>> >>> Aside from these two issues :-) PETSc would be useful for you since >>> you could use our time integrators and nonlinear solvers. Pulling out >>> subvectors to process on can be done with with either VecScatter or >>> VecStrideScatter, VecStrideGather etc depending on the layout of the >>> unknowns, i.e. how the domain decomposition is done. >>> >>> I wish I had better answers for managing the 6d domain decomposition >>> >>> Barry >>> >>> >>> >>> >>> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov >>>> wrote: >>>> >>>> Dear All, >>>> >>>> I am a new PETSc user and I am still in the middle of the manual (I >>>> have finally settled to choose PETSc as my main numerical library) so I am >>>> sorry beforehand if my questions would be naive. >>>> >>>> I am trying to solve 6+1 dimensional Vlasov equation with spectral >>>> methods. More precisely, I will try to solve half-discretized equations of >>>> the form (approximate form) with pseudospectral Fourier method: >>>> >>>> (Equations are in latex format, the nice website to see them is >>>> https://www.codecogs.com/latex/eqneditor.php) >>>> >>>> \frac{dC_{m,m,p}}{dt} =\\ >>>> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} >>>> \right ) \\ >>>> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} >>>> \right ) \\ >>>> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} >>>> \right ) \\ >>>> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >>>> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y >>>> (\dots) + B_z (\dots) >>>> >>>> >>>> where a,b,c,d,e,f are some constants which can depend on n,m,p, >>>> >>>> n,m,p = 0...N, >>>> >>>> C_{n,m,p} = C_{n,m,p}(x,y,z), >>>> >>>> E_x = E_x(x,y,z), (same for E_y,B_x,...) >>>> >>>> and fields are described with equation of the sort (linear pdes with >>>> source terms dependent on C): >>>> >>>> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + >>>> BC_{0,0,0}) \\ >>>> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >>>> >>>> with A,B being some constants. >>>> >>>> I will need fully implicit Crank?Nicolson method, so my plan is to use >>>> SNES or TS where >>>> >>>> I will use one MPI PETSc vector which describes the state of the system >>>> (all, C, E, B), then I can evolve linear part with just matrix >>>> multiplication. >>>> >>>> The first question is, should I use something like DMDA? if so, it is >>>> only 3dimensional but I need 6 dimensional vectots? Will it be faster then >>>> matrix multiplication? >>>> >>>> Then to do nonlinear part I will need 3d mpi-fftw to compute >>>> convolutions. The problem is, how do I extract subvectors from full big >>>> vector state? (what is the best approach?) >>>> >>>> If you have some other suggestions, please feel free to share >>>> >>>> Thanks and best regards, >>>> >>>> Oleksandr Koshkarov. >>>> >>>> >> > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which their > experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ > > > -- What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. -- Norbert Wiener http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From olk548 at mail.usask.ca Sun Jul 30 14:04:55 2017 From: olk548 at mail.usask.ca (Oleksandr Koshkarov) Date: Sun, 30 Jul 2017 13:04:55 -0600 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> Message-ID: Yes, It seems I am wrong and you are right. I think I can then make electric and magnetic fields local and do parallel partitioning only in v space - it will defiantly restrict the problem size, but maybe the code still be still useful and I get petsc experience with it :) The question here if I will just parallize along v-space, the 3d DMDA should be enough, right? I do not really understand how would I do the partitioning here, can you please give me some hints? Another approach is to abandon global Fourier, let say for education purposes I will pick some finite difference along spacial dimensions, how would you advice me to partition this problem with PETSc then? I know something like spectral elements or discontinuous Galerkin will be ideal, but I want to get petsc experience first with simpler problem and then move to discontinuous Galerkin (this will be defiantly the next step). (Unfortunately, I have never done any unstructured meshes like spectral elements or discontinuous Galerkin myself before, but did some finite difference and spectral methods) On 07/30/2017 12:46 PM, Matthew Knepley wrote: > On Sun, Jul 30, 2017 at 12:44 PM, Oleksandr Koshkarov > > wrote: > > Thanks for the references, and warning. > > I am trying to do exactly this > > http://www.sciencedirect.com/science/article/pii/S0021999115004738 > > > (I probably should have added the reference in the first place, sorry) > > the evolution formula is (15) in the article. > > So, I will do convolution only in 3D (while full system is 6D) > because velocity space is not discretized with Fourier > > So As I understand, it will not be N^2 vs N logN. Moreover, I know > that algorithm with FFT has significantly larger "constant". > > Please correct me if I am wrong here :) > > I think you are wrong here. First, I do not understand why you think > the asymptotics have changed. Second, the constant for > FFT is about 6, which would be really hard to beat with a quadrature. > > Last, this discretization looks fully coupled to me. I cannot see how > you would parallelize this right off the bat. This is a problem > with spectral discretizations, and the main motivator for spectral > elements. > > Thanks, > > Matt > > I know for sure that FFT is a must at the end, but I thought I can > start with matrix product to get more familiar with PETSc as it > will be simpler to implement (At least I think so). > > I hope it does make sense. > > Another question about convolution via matrix product. Is there > better way to do it other then to construct NxN Toeplitz-like > matrix each time step on the "fly" from state vector and then > multiply it to state vector? > > p.s. Probably I should do FFT from the start, but I am a little > bit intimidated by the problem taking into account that I do not > have PETSc experience. > > Best regards, > Oleksandr Koshkarov. > > On 07/30/2017 09:01 AM, Matthew Knepley wrote: >> On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov >> > wrote: >> >> Thank you for the response, >> >> Now that you said about additional communication for fft, I >> want to ask another question: >> >> What if I disregard FFT and will compute convolution >> directly, I will rewrite it as vector-matrix-vector product >> >> >> I would caution you here. The algorithm is the most important >> thing to get right up front. In this case, the effect of >> dimension will be dominant, and anything that does not scale well >> with dimension will be thrown away, perhaps >> quite quickly, as you want to solve bigger problems. >> >> Small calculation: Take a 6-dim box which is 'n' on a side, so >> that N = n^6. FFT is N log N, whereas direct evaluation of >> a convolution is N^2. So if we could do n = 100 points on a side >> with FFT, you can do, assuming the constants are about >> equal, >> >> 100^6 (log 100^6) = x^12 >> 1e12 (6 2) = x^12 >> x ~ 10 >> >> Past versions of PETSc had a higher dimensional DA construct >> (adda in prior versions), but no one used it so we removed it. >> >> I assume you are proposing something like >> >> https://arxiv.org/abs/1306.4625 >> >> or maybe >> >> https://arxiv.org/abs/1610.00397 >> >> The later is interesting since I think you could use a DMDA for >> the velocity and something like DMPlex for the space. >> >> Thanks, >> >> Matt >> >> x^T A x (where T - is transpose, x - is my state vector, and >> A is a matrix which represents convolution and probably it >> will be not very sparse). >> >> Yes - I will do more work (alghorithm will be slower), but >> will I win if we take the parallelization into account - less >> communication + probably more scalable algorithm? >> >> Best regards, >> >> Alex. >> >> >> >> On 07/29/2017 05:23 PM, Barry Smith wrote: >> >> DMDA provides a simple way to do domain decomposition of >> structured grid meshes in the x, y, and z direction, that >> is it makes it easy to efficiently chop up vectors in all >> 3 dimensions, allowing very large problems easily. >> Unfortunately it only goes up to 3 dimensions and >> attempts to produce versions for higher dimensions have >> failed. >> >> If you would like to do domain decomposition across >> all six of your dimensions (which I think you really need >> to do to solve large problems) we don't have a tool that >> helps with doing the domain decomposition. To make >> matters more complicated, likely the 3d mpi-fftw that >> need to be applied require rejiggering the data across >> the nodes to get it into a form where the ffts can be >> applied efficiently. >> >> I don't think there is necessarily anything >> theoretically difficult about managing the six >> dimensional domain decomposition I just don't know of any >> open source software out there that helps to do this. >> Maybe some PETSc users are aware of such software and can >> chime in. >> >> Aside from these two issues :-) PETSc would be useful >> for you since you could use our time integrators and >> nonlinear solvers. Pulling out subvectors to process on >> can be done with with either VecScatter or >> VecStrideScatter, VecStrideGather etc depending on the >> layout of the unknowns, i.e. how the domain decomposition >> is done. >> >> I wish I had better answers for managing the 6d >> domain decomposition >> >> Barry >> >> >> >> >> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov >> > >> wrote: >> >> Dear All, >> >> I am a new PETSc user and I am still in the middle of >> the manual (I have finally settled to choose PETSc as >> my main numerical library) so I am sorry beforehand >> if my questions would be naive. >> >> I am trying to solve 6+1 dimensional Vlasov equation >> with spectral methods. More precisely, I will try to >> solve half-discretized equations of the form >> (approximate form) with pseudospectral Fourier method: >> >> (Equations are in latex format, the nice website to >> see them is >> https://www.codecogs.com/latex/eqneditor.php >> ) >> >> \frac{dC_{m,m,p}}{dt} =\\ >> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} >> +c_n C_{n-1,m,p} \right ) \\ >> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} >> +c_m C_{n,m-1,p} \right ) \\ >> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} >> +c_p C_{n,m,p-1} \right ) \\ >> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x >> C_{n,m,p-1} \\ >> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + >> \dots) + B_y (\dots) + B_z (\dots) >> >> >> where a,b,c,d,e,f are some constants which can depend >> on n,m,p, >> >> n,m,p = 0...N, >> >> C_{n,m,p} = C_{n,m,p}(x,y,z), >> >> E_x = E_x(x,y,z), (same for E_y,B_x,...) >> >> and fields are described with equation of the sort >> (linear pdes with source terms dependent on C): >> >> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + >> (AC_{1,0,0} + BC_{0,0,0}) \\ >> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >> >> with A,B being some constants. >> >> I will need fully implicit Crank?Nicolson method, so >> my plan is to use SNES or TS where >> >> I will use one MPI PETSc vector which describes the >> state of the system (all, C, E, B), then I can >> evolve linear part with just matrix multiplication. >> >> The first question is, should I use something like >> DMDA? if so, it is only 3dimensional but I need 6 >> dimensional vectots? Will it be faster then matrix >> multiplication? >> >> Then to do nonlinear part I will need 3d mpi-fftw to >> compute convolutions. The problem is, how do I >> extract subvectors from full big vector state? (what >> is the best approach?) >> >> If you have some other suggestions, please feel free >> to share >> >> Thanks and best regards, >> >> Oleksandr Koshkarov. >> >> >> >> >> >> -- >> What most experimenters take for granted before they begin their >> experiments is infinitely more interesting than any results to >> which their experiments lead. >> -- Norbert Wiener >> >> http://www.caam.rice.edu/~mk51/ > > > > > -- > What most experimenters take for granted before they begin their > experiments is infinitely more interesting than any results to which > their experiments lead. > -- Norbert Wiener > > http://www.caam.rice.edu/~mk51/ -------------- next part -------------- An HTML attachment was scrubbed... URL: From bsmith at mcs.anl.gov Sun Jul 30 17:35:04 2017 From: bsmith at mcs.anl.gov (Barry Smith) Date: Sun, 30 Jul 2017 17:35:04 -0500 Subject: [petsc-users] help me to solve 6-dim PDE with PETSc with advice In-Reply-To: References: <8ee93603-a928-52a4-2127-a647952ea116@mail.usask.ca> <63900532-C627-445F-BFAB-2943D385174E@mcs.anl.gov> <2ac0e117-9f4d-f93e-d768-69e2019d8972@mail.usask.ca> <7bb63e5e-d724-2079-add7-591e35084fa1@mail.usask.ca> Message-ID: > On Jul 30, 2017, at 2:04 PM, Oleksandr Koshkarov wrote: > > Yes, It seems I am wrong and you are right. > > I think I can then make electric and magnetic fields local and do parallel partitioning only in v space - it will defiantly restrict the problem size, but maybe the code still be still useful and I get petsc experience with it :) The question here if I will just parallize along v-space, the 3d DMDA should be enough, right? I do not really understand how would I do the partitioning here, can you please give me some hints? You could do this, it is tempting due to its simplicity. Let Mv,Nv, and Pv represent the number of grid points in the three velocity directions and Mx, Nx, Px represent the number of grid points in physical space. If you have three unknowns at each grid point represented by C, E, B then you would define dof = 3*Mx*Nx*Px Create your DMDACreate3d() using Mv,Nv, and Pv and dof then each process will have a certain number of velocity "grid" points and at each grid point there will room for all the physical points (times 3 for each unknown). So think of it as a three dimensional array with all the dependence on spatial grid point variables stacked up on top of each other. If you call DMDAVecGetArray() the resulting array will be indexed as array[kv][jv][iv][ilocal] where kv is the third grid component of velocity etc and ilocal goes from 0 to 3*Mx*Nx*Px. You can decide if you want to store the C, E, B interlaced (meaning array[kv][jv][iv][0] is the first C, array[kv][jv][iv][1] is the first E ...) or uninterlaced (meaning array[kv][jv][iv][0:Mx*Nx*Px] are the C etc). If you use noninterlaced then applying a 3d FFT to a particular component is straightforward since they are all stored next to each other. This is definitely not a scalable approach but you might be able to have Mx = My = Mz = 128 which is not bad for a spectral method. I recommend starting by writing a simple code that does this first with 2d spatial and 2d, it is just so much easy to reason about a two array as you get the kinks out of the code. Barry > > Another approach is to abandon global Fourier, let say for education purposes I will pick some finite difference along spacial dimensions, how would you advice me to partition this problem with PETSc then? > > > I know something like spectral elements or discontinuous Galerkin will be ideal, but I want to get petsc experience first with simpler problem and then move to discontinuous Galerkin (this will be defiantly the next step). (Unfortunately, I have never done any unstructured meshes like spectral elements or discontinuous Galerkin myself before, but did some finite difference and spectral methods) > > On 07/30/2017 12:46 PM, Matthew Knepley wrote: >> On Sun, Jul 30, 2017 at 12:44 PM, Oleksandr Koshkarov wrote: >> Thanks for the references, and warning. >> >> I am trying to do exactly this >> http://www.sciencedirect.com/science/article/pii/S0021999115004738 >> >> (I probably should have added the reference in the first place, sorry) >> >> the evolution formula is (15) in the article. >> >> So, I will do convolution only in 3D (while full system is 6D) because velocity space is not discretized with Fourier >> >> So As I understand, it will not be N^2 vs N logN. Moreover, I know that algorithm with FFT has significantly larger "constant". >> >> Please correct me if I am wrong here :) >> >> I think you are wrong here. First, I do not understand why you think the asymptotics have changed. Second, the constant for >> FFT is about 6, which would be really hard to beat with a quadrature. >> >> Last, this discretization looks fully coupled to me. I cannot see how you would parallelize this right off the bat. This is a problem >> with spectral discretizations, and the main motivator for spectral elements. >> >> Thanks, >> >> Matt >> I know for sure that FFT is a must at the end, but I thought I can start with matrix product to get more familiar with PETSc as it will be simpler to implement (At least I think so). >> >> I hope it does make sense. >> >> Another question about convolution via matrix product. Is there better way to do it other then to construct NxN Toeplitz-like matrix each time step on the "fly" from state vector and then multiply it to state vector? >> >> p.s. Probably I should do FFT from the start, but I am a little bit intimidated by the problem taking into account that I do not have PETSc experience. >> Best regards, >> Oleksandr Koshkarov. >> >> On 07/30/2017 09:01 AM, Matthew Knepley wrote: >>> On Sat, Jul 29, 2017 at 7:01 PM, Oleksandr Koshkarov wrote: >>> Thank you for the response, >>> >>> Now that you said about additional communication for fft, I want to ask another question: >>> >>> What if I disregard FFT and will compute convolution directly, I will rewrite it as vector-matrix-vector product >>> >>> I would caution you here. The algorithm is the most important thing to get right up front. In this case, the effect of >>> dimension will be dominant, and anything that does not scale well with dimension will be thrown away, perhaps >>> quite quickly, as you want to solve bigger problems. >>> >>> Small calculation: Take a 6-dim box which is 'n' on a side, so that N = n^6. FFT is N log N, whereas direct evaluation of >>> a convolution is N^2. So if we could do n = 100 points on a side with FFT, you can do, assuming the constants are about >>> equal, >>> >>> 100^6 (log 100^6) = x^12 >>> 1e12 (6 2) = x^12 >>> x ~ 10 >>> >>> Past versions of PETSc had a higher dimensional DA construct (adda in prior versions), but no one used it so we removed it. >>> >>> I assume you are proposing something like >>> >>> https://arxiv.org/abs/1306.4625 >>> >>> or maybe >>> >>> https://arxiv.org/abs/1610.00397 >>> >>> The later is interesting since I think you could use a DMDA for the velocity and something like DMPlex for the space. >>> >>> Thanks, >>> >>> Matt >>> >>> x^T A x (where T - is transpose, x - is my state vector, and A is a matrix which represents convolution and probably it will be not very sparse). >>> >>> Yes - I will do more work (alghorithm will be slower), but will I win if we take the parallelization into account - less communication + probably more scalable algorithm? >>> >>> Best regards, >>> >>> Alex. >>> >>> >>> >>> On 07/29/2017 05:23 PM, Barry Smith wrote: >>> DMDA provides a simple way to do domain decomposition of structured grid meshes in the x, y, and z direction, that is it makes it easy to efficiently chop up vectors in all 3 dimensions, allowing very large problems easily. Unfortunately it only goes up to 3 dimensions and attempts to produce versions for higher dimensions have failed. >>> >>> If you would like to do domain decomposition across all six of your dimensions (which I think you really need to do to solve large problems) we don't have a tool that helps with doing the domain decomposition. To make matters more complicated, likely the 3d mpi-fftw that need to be applied require rejiggering the data across the nodes to get it into a form where the ffts can be applied efficiently. >>> >>> I don't think there is necessarily anything theoretically difficult about managing the six dimensional domain decomposition I just don't know of any open source software out there that helps to do this. Maybe some PETSc users are aware of such software and can chime in. >>> >>> Aside from these two issues :-) PETSc would be useful for you since you could use our time integrators and nonlinear solvers. Pulling out subvectors to process on can be done with with either VecScatter or VecStrideScatter, VecStrideGather etc depending on the layout of the unknowns, i.e. how the domain decomposition is done. >>> >>> I wish I had better answers for managing the 6d domain decomposition >>> >>> Barry >>> >>> >>> >>> >>> On Jul 29, 2017, at 5:06 PM, Oleksandr Koshkarov wrote: >>> >>> Dear All, >>> >>> I am a new PETSc user and I am still in the middle of the manual (I have finally settled to choose PETSc as my main numerical library) so I am sorry beforehand if my questions would be naive. >>> >>> I am trying to solve 6+1 dimensional Vlasov equation with spectral methods. More precisely, I will try to solve half-discretized equations of the form (approximate form) with pseudospectral Fourier method: >>> >>> (Equations are in latex format, the nice website to see them is https://www.codecogs.com/latex/eqneditor.php) >>> >>> \frac{dC_{m,m,p}}{dt} =\\ >>> \partial_x \left ( a_n C_{n+1,m,p} +b_n C_{n,m,p} +c_n C_{n-1,m,p} \right ) \\ >>> + \partial_y \left ( a_m C_{n,m+1,p} +b_m C_{n,m,p} +c_m C_{n,m-1,p} \right ) \\ >>> + \partial_z \left ( a_p C_{n,m,p+1} +b_p C_{n,m,p} +c_p C_{n,m,p-1} \right ) \\ >>> + d_n E_x C_{n-1,m,p} + d_m E_x C_{n,m-1,p} + d_p E_x C_{n,m,p-1} \\ >>> + B_x (e_{m,p} C_{n,m-1,p-1} + f_{m,p}C_{n,m-1,p+1} + \dots) + B_y (\dots) + B_z (\dots) >>> >>> >>> where a,b,c,d,e,f are some constants which can depend on n,m,p, >>> >>> n,m,p = 0...N, >>> >>> C_{n,m,p} = C_{n,m,p}(x,y,z), >>> >>> E_x = E_x(x,y,z), (same for E_y,B_x,...) >>> >>> and fields are described with equation of the sort (linear pdes with source terms dependent on C): >>> >>> \frac{dE_x}{dt} = \partial_y B_z - \partial_z B_x + (AC_{1,0,0} + BC_{0,0,0}) \\ >>> \frac{dB_x}{dt} = -\partial_y E_z + \partial_z E_x >>> >>> with A,B being some constants. >>> >>> I will need fully implicit Crank?Nicolson method, so my plan is to use SNES or TS where >>> >>> I will use one MPI PETSc vector which describes the state of the system (all, C, E, B), then I can evolve linear part with just matrix multiplication. >>> >>> The first question is, should I use something like DMDA? if so, it is only 3dimensional but I need 6 dimensional vectots? Will it be faster then matrix multiplication? >>> >>> Then to do nonlinear part I will need 3d mpi-fftw to compute convolutions. The problem is, how do I extract subvectors from full big vector state? (what is the best approach?) >>> >>> If you have some other suggestions, please feel free to share >>> >>> Thanks and best regards, >>> >>> Oleksandr Koshkarov. >>> >>> >>> >>> >>> >>> -- >>> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >>> -- Norbert Wiener >>> >>> http://www.caam.rice.edu/~mk51/ >> >> >> >> >> -- >> What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead. >> -- Norbert Wiener >> >> http://www.caam.rice.edu/~mk51/ > From giuntoli1991 at gmail.com Mon Jul 31 04:27:13 2017 From: giuntoli1991 at gmail.com (Guido Giuntoli) Date: Mon, 31 Jul 2017 11:27:13 +0200 Subject: [petsc-users] Command Line Message-ID: Hi, I have a program with the following structure ... PETSC_COMM_WORLD = WORLD_COMM; ierr = PetscInitialize(&argc,&argv,(char*)0,help); ierr = PetscOptionsGetBool(NULL, NULL, "-flag", &flag, &set); CHKERRQ(ierr); ... ierr = PetscFinalize(); PETSC_COMM_WORLD = ANOTHER_COMM; ierr = PetscInitialize(&argc,&argv,(char*)0,help); ... ierr = PetscFinalize(); ... The problem I want to avoid is PETSc to print "WARNING! There are options you set that were not used!" In the first part I use some options of the command line and in the second I am going to use others like the -ksp_xxxx. Which is the good way of avoiding that without touching petsc code ? Thanks, Guido. -------------- next part -------------- An HTML attachment was scrubbed... URL: From stefano.zampini at gmail.com Mon Jul 31 04:40:05 2017 From: stefano.zampini at gmail.com (Stefano Zampini) Date: Mon, 31 Jul 2017 12:40:05 +0300 Subject: [petsc-users] Command Line In-Reply-To: References: Message-ID: You can do it with the command line option "-options_left 0" 2017-07-31 12:27 GMT+03:00 Guido Giuntoli : > Hi, I have a program with the following structure > > ... > PETSC_COMM_WORLD = WORLD_COMM; > ierr = PetscInitialize(&argc,&argv,(char*)0,help); > ierr = PetscOptionsGetBool(NULL, NULL, "-flag", &flag, &set); > CHKERRQ(ierr); > ... > ierr = PetscFinalize(); > PETSC_COMM_WORLD = ANOTHER_COMM; > ierr = PetscInitialize(&argc,&argv,(char*)0,help); > ... > ierr = PetscFinalize(); > ... > > The problem I want to avoid is PETSc to print > > "WARNING! There are options you set that were not used!" > > In the first part I use some options of the command line and in the second > I am going to use others like the -ksp_xxxx. Which is the good way of > avoiding that without touching petsc code ? > > Thanks, Guido. > -- Stefano -------------- next part -------------- An HTML attachment was scrubbed... URL: