Skip to content

Valgrind Error Details

back to process details
back to processes overview
Executable/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
PID26196
PPID16382
Unique ID0xfb6
Text17,536 bytes in 1 blocks are still reachable in loss record 4,021 of 4,065
Auxiliary
Suppression{
   <insert_a_suppression_name_here>
   Memcheck:Leak
   match-leak-kinds: reachable
   fun:malloc
   fun:PXAllocate
   fun:PXPrecalcFaceMasterPolynomial
   fun:PXGetMasterPolynomialFace
   fun:PXIFacePrimalJumpResidual
   fun:PXIFaceJumpResidual
   fun:PXJumpResidual.isra.14
   fun:PXCalculateResidual
   fun:PXSolveNonlinearPrimalNewton
   fun:PXSolveNonlinearProblem
   fun:PXSolveUnsteadyStep
   fun:PXSolveUnsteadyProblem
   fun:PXSolvePrimal
   fun:PXPSequencing
   fun:main
}

Stacktrace

Object/usr/lib/valgrind/vgpreload_memcheck-amd64-linux.so
Functionmalloc
File/Line
CodeSource code not available

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXAllocate
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/Fundamentals/PXMemory.c:99
Code
089 
090 
091   tot = n*size;
092   
093   if (likely(tot)){
094     if (unlikely(n<0)){
095       printf("Error, requesting allocation of negative memory size.\n"); fflush(stdout);
096       *po = NULL;
097       return PXError(PX_MEMORY_ERROR);
098     }
099     else if unlikely(( _po = (char *)malloc(tot)) == NULL) ){
100       *po = NULL;
101       return PXError(PX_MEMORY_ERROR);
102     }
103   }
104   *po = (void *_po;

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXPrecalcFaceMasterPolynomial
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/Reference/PXMasterPolynomial.c:224
Code
214 int
215 PXPrecalcFaceMasterPolynomial(int Dim, enum PXE_SolutionOrder order, int nFace, int nOrientation, int nquad, PX_REAL const * RESTRICT xref, PX_MasterPolynomial * RESTRICT * RESTRICT masterPoly){
216   PX_REAL * RESTRICT phi = NULL, * RESTRICT gphi = NULL;
217   int iface, iOrientation, iquad;
218   int porder, nbf;
219   enum PXE_Shape shape;
220   enum PXE_BASISTYPE basisType;
221 
222   PXOrder2nbf(order, &nbf);
223 
224   PXErrorReturnPXAllocatesizeof(PX_MasterPolynomial+ nFace*nOrientation*(Dim+1)*nbf*nquad, sizeof(PX_REAL)(void **)&(*masterPoly) ) )
225   phi =  (PX_REAL *) ((*masterPoly1);
226   gphi = phi + nbf*nquad;
227 
228   PXOrder2porder(order, &porder);
229   PXGetOrderBasisType(order, &basisType);

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXGetMasterPolynomialFace
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/Reference/PXMasterPolynomial.c:381
Code
371 PXGetMasterPolynomialFace(PX_PolynomialPrecalcStruct * PolyPrecalcStruct, int quad_order, enum PXE_Shape shape, enum PXE_QuadratureRule quadRule, enum PXE_SolutionOrder order, PX_MasterPolynomial const ** MasterPolyData){
372   ifunlikely(PolyPrecalcStruct->MasterPolynomialFaceLookup[shape][quadRule][order== NULL) ){
373     int nFace;
374     /* Make sure quadrature rule exists */
375     ifunlikely(PolyPrecalcStruct->QuadFaceLookup[shape][quadRule== NULL) ){
376       PXErrorReturnPXComputeQuadFacePrecalc(PolyPrecalcStruct->Dim, quad_order, shape, &(PolyPrecalcStruct->QuadFaceLookup[shape][quadRule])) );
377     }
378 
379     PXShape2nFace(shape, &nFace);
380 
381     PXErrorReturnPXPrecalcFaceMasterPolynomial(PolyPrecalcStruct->Dim, order, nFace, PolyPrecalcStruct->QuadFaceLookup[shape][quadRule]->nOrientation, PolyPrecalcStruct->QuadFaceLookup[shape][quadRule]->nquad, PolyPrecalcStruct->QuadFaceLookup[shape][quadRule]->xquadElemRef, &PolyPrecalcStruct->MasterPolynomialFaceLookup[shape][quadRule][order]) );
382   }
383 
384   if(MasterPolyData != NULL)
385     *MasterPolyData = PolyPrecalcStruct->MasterPolynomialFaceLookup[shape][quadRule][order];
386 

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXIFacePrimalJumpResidual
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/PXResidual.c:5202
Code
05192     for(iquad=0; iquad<nquad; iquad++){
05193       PXErrorReturnPXFaceNormal(pg, fgrp, face, xquad + (Dim-1)*iquad, NVEC+Dim*iquad, NULL) );
05194     }
05195 
05196     phiLStart = MasterPolyDataL->phi + (lfaceL*nOrientation + orientationL)*(Dim+1)*nbfL*nquad;
05197     gphiLStart = MasterPolyDataL->phi + (lfaceL*nOrientation + orientationL)*(Dim+1)*nbfL*nquad + nbfL*nquad;
05198 
05199     phiRStart = MasterPolyDataR->phi + (lfaceR*nOrientation + orientationR)*(Dim+1)*nbfR*nquad;
05200     gphiRStart = MasterPolyDataR->phi + (lfaceR*nOrientation + orientationR)*(Dim+1)*nbfR*nquad + nbfR*nquad;
05201 
05202     PXGetMasterPolynomialFace(PolynomialPrecalcStruct_GLOBAL, quad_order, shapeL, quad_rule, orderLQ, &MasterPolyDataL);
05203     gphiLQStart = MasterPolyDataL->phi + (lfaceL*nOrientation + orientationL)*(Dim+1)*nbfLQ*nquad + nbfLQ*nquad;
05204 
05205     PXGetMasterPolynomialFace(PolynomialPrecalcStruct_GLOBAL, quad_order, shapeR, quad_rule, orderRQ, &MasterPolyDataR);
05206     phiRQStart = MasterPolyDataR->phi + (lfaceR*nOrientation + orientationR)*(Dim+1)*nbfRQ*nquad;
05207     gphiRQStart = MasterPolyDataR->phi + (lfaceR*nOrientation + orientationR)*(Dim+1)*nbfRQ*nquad + nbfRQ*nquad;

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXIFaceJumpResidual
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/PXResidual.c:11237
Code
11227     pRL_UR = RL_UR;
11228     pRR_UL = RR_UL;
11229     pRR_UR = RR_UR;
11230   }
11231   /*****************************************************/
11232 
11233   /* Evaluate Jump Residual: need to distinguish interior fgrp and interface fgrp */
11234   ParentFaceGroup = (pg->FaceGroup[fgrp].FaceGroupFlag == PXE_GhostedFG? fgrp - pg->nFaceGroup : fgrp;
11235   ParentFaceGroup = (pg->FaceGroup[ParentFaceGroup].ParentFaceGroup >= 0? pg->FaceGroup[ParentFaceGroup].ParentFaceGroup : ParentFaceGroup;
11236   if(pg->FaceGroup[ParentFaceGroup].FaceGroupFlag == PXE_InteriorFG//interior face
11237     PXErrorReturn(PXIFacePrimalJumpResidual (pxa, ResJobParams, ResIFaceData, fgrp, face, orderL, orderR, UL, UR, RL, RR, pRL_UL, pRR_UR, pRL_UR, pRR_UL) );
11238   else //interface
11239     PXErrorReturn(PXInterfacePrimalJumpResidual (pxa, ResJobParams, ResIFaceData, fgrp, face, orderL, orderR, UL, UR, RL, RR, pRL_UL, pRR_UR, pRL_UR, pRR_UL) );
11240 
11241 
11242   /*****************************************************/

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXJumpResidual.isra.14
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/PXResidual.c:11579
Code
11569 
11570       PXErrorReturnPXInvMassMatrix(pg, egL, eL, orderL, 1.0, &(ResIFaceData.iMML)) );
11571       PXErrorReturnPXInvMassMatrix(pg, egR, eR, orderR, 1.0, &(ResIFaceData.iMMR)) );
11572 
11573       ResIFaceData.H = GenH->value[egL][eL];
11574       ResIFaceData.orderH = GenH->order[egL];
11575       PXErrorReturn(PXOrder2nbf(ResIFaceData.orderH,&nbfH));
11576       ResIFaceData.nbfH = nbfH;
11577 
11578       /* calculate the jump term of the residual */
11579       PXErrorReturn (PXIFaceJumpResidual(pxa, ResJobParams, &ResIFaceData, fgrp, face, orderL, orderR,
11580                                          UL, AdjL, TanL,
11581                                          UR, AdjR, TanR,
11582                                          RL, AdjRL, TanRL,
11583                                          RR, AdjRR, TanRR,
11584                                          RL_UL, RR_UR,

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXCalculateResidual
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/PXResidual.c:16337
Code
16327 
16328   //PXErrorReturn( PXPrecalcFaceThings(pxa, State->order) );
16329 #if PREALLOC == 1
16330   PXErrorReturnPXPreAllocateIFaceThings(pxa, &ResJobParams, State->order, -1, -1, calcJacobianFlag) );
16331 #endif
16332 
16333 #ifdef PX_TIMING
16334   //c6 = PXclock();
16335 #endif
16336   /* Interior faces */
16337   PXErrorReturnPXJumpResidualpxa, &ResJobParams, PXE_False, State, AdjState, TanState,
16338                                  Res, AdjRes, TanRes, DGSolverStruct));
16339 #ifdef PX_TIMING
16340   //c7 = PXclock();
16341 #endif
16342 

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXSolveNonlinearPrimalNewton
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/PXSolver.c:6898
Code
06888     /*--------------------------*/
06889     /* Compute Spatial Residual */
06890     /*--------------------------*/
06891 
06892     if unlikely(PingFlag == PXE_PingLocal) ) {
06893       PXErrorReturn(PXPingResidualFast(pxa, State));
06894     }else ifunlikely(PingFlag == PXE_PingGlobal) ){
06895       PXErrorReturn(PXPingResidualFull(pxa, State));
06896     }
06897 
06898     terr =  PXCalculateResidual(pxa, mode, State, NULL, NULL, Residual, NULL, NULL,
06899                                 DGSolverStruct);
06900     /* Check that the flow state does not need to be rewound */
06901     PXErrorReturnPXCheckRewindpxa, terr, UpdateState, State, ValidState,
06902                                   NULL, NULL, &CFL, &CFLValid,
06903                                   &RewindFlag ) );

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXSolveNonlinearProblem
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/PXSolver.c:8862
Code
08852     /* Set number of adjoint outputs */
08853     nSensParam = pxa->SensitivityStruct->nSensParam;
08854     /* Allocate adjoint residual norm array */
08855     PXErrorReturnPXAllocatenSensParam, sizeof(PX_REAL),
08856                                (void **)&(TanResidualNorm) ) );
08857   }
08858 
08859   switch NonlinearSolver ){
08860   case PXE_Newton:
08861     if FlowFlag == PXE_True ){
08862       ierr = PXSolveNonlinearPrimalNewtonpxa, MaxIter, unsteadyWeight,
08863                                            mode, CFLStart,
08864                                            &ResidualTol, &ResidualNorm,
08865                                            State0, Source, State, Residual, &smResIter);
08866       if ierr !=PX_NO_ERROR && ierr !=PX_NOT_CONVERGED PXErrorReturn(ierr);
08867     }

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXSolveUnsteadyStep
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/PXSolver.c:9320
Code
09310                                                            TanSpatialRes ) );
09311 
09312         /* Set flag to converged for this stage */
09313         ConvergedFlag = PXE_True;
09314       }
09315       else
09316       {
09317         /*----------------------------------------------*/
09318         /* Solve the problem using the nonlinear solver */
09319         /*----------------------------------------------*/
09320         PXErrorReturn(
09321             PXSolveNonlinearProblempxa, unsteadyWeight, mode,
09322                                      NULL, Source, State, StageRes[iStage],
09323                                      NULL, NULL, NULL, NULL, /* No Adjoint */
09324                                      NULL, TanSource, TanState, TanRes,
09325                                      &ResidualNorm, NULL, NULL,

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXSolveUnsteadyProblem
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/PXSolver.c:9855
Code
09845 
09846 
09847     }
09848     else{
09849 
09850       StageState[0= State;
09851 
09852     }
09853 
09854     /* Call time step solver */
09855     PXErrorReturnPXSolveUnsteadyStep(pxa, currentIndex, UnsteadyStruct,
09856                                        UnsteadyFlag, PXE_Mode_Solve,
09857                                        StageState,
09858                                        (PrevState!=NULL)?PrevState[0]:NULL,
09859                                            PrevState,
09860                                            StageResidual, Source, StateSource,

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXSolvePrimal
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/PXRunSolver.c:386
Code
0376   PXPrintf("\n***************\n");
0377   PXPrintf(  " Primal Solver \n");
0378   PXPrintf(  "***************\n");
0379 
0380   if Discretization == PXE_Discretization_HDG ) {
0381     /* HDG discretization */
0382     PXErrorReturnPXHDGSolve(pxa, &ConvergedFlag) );
0383   }
0384   else {
0385     /* DG discretization */
0386     PXErrorReturnPXSolveUnsteadyProblem(pxa, &ConvergedFlag) );
0387   }
0388 
0389   /*-------------------*/
0390   /* Write Output File */
0391   /*-------------------*/

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
FunctionPXPSequencing
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/PXRunSolver.c:681
Code
0671 
0672     /*----------------------*/
0673     /* Solve Primal Problem */
0674     /*----------------------*/
0675 
0676 #ifdef PX_TIMING
0677     PXBarrier();
0678     c0 = PXclock();
0679 #endif
0680 
0681     PXErrorReturnPXSolvePrimal(pxa, AdaptFlag, aiter, &ConvergedFlag, &iSolOrder) );
0682 
0683 
0684 #ifdef PX_TIMING
0685     PXBarrier();
0686     c1 = PXclock();

Object/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/platforms/relwithdebinfo_gnu/bin/ProjectXExec
Functionmain
File/Line/home1/jenkins/workspace/ProjectX_Weekly/PX_ARC/relwithdebinfo_gnu/buildnode/reynolds/src/PXRunSolver.c:999
Code
0989     PXErrorReturnPXInitializeAdaptIterpxa, aiter ) );
0990     //pg = pxa->pg;
0991 
0992 #ifdef PX_TIMING
0993     PXBarrier();
0994     c2=PXclock();
0995     PXPrintf("Time : (InitializeAdaptIter) = %f\n", c2 - c1 );
0996 #endif
0997 
0998     /* Perform PSequencing */
0999     PXErrorReturnPXPSequencingpxa, AdaptFlag, aiter, &ConvergedFlag ) );
1000 
1001 #ifdef PX_TIMING
1002     PXBarrier();
1003     c1=PXclock();
1004     PXPrintf("Time : (PXPSequencing) = %f\n",  c1 - c2);