Skip to content

Commit

Permalink
Merge pull request ANTsX#1669 from ANTsX/ANTsWarnings
Browse files Browse the repository at this point in the history
COMP:  Address warnings.
ntustison authored Jan 30, 2024
2 parents 128c124 + 02230b3 commit 8f25651
Showing 5 changed files with 135 additions and 135 deletions.
216 changes: 108 additions & 108 deletions Examples/ImageMath_Templates.hxx
Original file line number Diff line number Diff line change
@@ -448,12 +448,12 @@ GetLargestComponent(int argc, char * argv[])
typename ImageType::Pointer image1 = nullptr;
ReadImage<ImageType>(image1, fn1.c_str());
// compute the voxel volume
typename ImageType::SpacingType spacing = image1->GetSpacing();
float volumeelement = 1.0;
for (unsigned int i = 0; i < spacing.Size(); i++)
{
volumeelement *= static_cast<float>(spacing[i]);
}
// typename ImageType::SpacingType spacing = image1->GetSpacing();
// float volumeelement = 1.0;
// for (unsigned int i = 0; i < spacing.Size(); i++)
// {
// volumeelement *= static_cast<float>(spacing[i]);
// }

typedef itk::Image<unsigned long, ImageDimension> labelimagetype;
typedef ImageType InternalImageType;
@@ -646,7 +646,7 @@ ClusterThresholdVariate(int argc, char * argv[])
// iterate through the image and set the voxels where countinlabel[(unsigned
// long)(labelimage->GetPixel(vfIter.GetIndex()) - min)]
// is < MinClusterSize
unsigned long vecind = 0;
// unsigned long vecind = 0;
fIterator mIter(mask, mask->GetLargestPossibleRegion());
for (mIter.GoToBegin(); !mIter.IsAtEnd(); ++mIter)
{
@@ -660,7 +660,7 @@ ClusterThresholdVariate(int argc, char * argv[])
{
image->SetPixel(mIter.GetIndex(), 0);
}
vecind++;
// vecind++;
}
}
}
@@ -1482,20 +1482,20 @@ ConvertVectorToImage(unsigned int argc, char * argv[])
ReadImage<ImageType>(mask, maskfn.c_str());
typename MatrixImageType::Pointer vecimg = nullptr;
ReadImage<MatrixImageType>(vecimg, vecfn.c_str());
unsigned long voxct = 0, mct = 0;
// unsigned long voxct = 0, mct = 0;
Iterator mIter(mask, mask->GetLargestPossibleRegion());
for (mIter.GoToBegin(); !mIter.IsAtEnd(); ++mIter)
{
if (mIter.Get() >= 0.5f)
{
mct++;
}
}
// for (mIter.GoToBegin(); !mIter.IsAtEnd(); ++mIter)
// {
// if (mIter.Get() >= 0.5f)
// {
// mct++;
// }
// }
vIterator vIter(vecimg, vecimg->GetLargestPossibleRegion());
for (vIter.GoToBegin(); !vIter.IsAtEnd(); ++vIter)
{
voxct++;
}
// for (vIter.GoToBegin(); !vIter.IsAtEnd(); ++vIter)
// {
// voxct++;
// }

// std::cout << " vct " << voxct << " mct " << mct << std::endl;

@@ -1577,25 +1577,25 @@ Where(int argc, char * argv[])
{
typedef float PixelType;
typedef itk::Image<PixelType, ImageDimension> ImageType;
typedef itk::ImageRegionIteratorWithIndex<ImageType> Iterator;
// typedef itk::ImageRegionIteratorWithIndex<ImageType> Iterator;

int argct = 4;
std::string fn1 = std::string(argv[argct]);
argct++;
float value = atof(argv[argct]);
// float value = atof(argv[argct]);
argct++;
std::string fn2 = "";
if (argc > argct)
{
fn2 = std::string(argv[argct]);
argct++;
}
float tol = 0.0;
if (argc > argct)
{
tol = atof(argv[argct]);
argct++;
}
// float tol = 0.0;
// if (argc > argct)
// {
// tol = atof(argv[argct]);
// argct++;
// }

typename ImageType::Pointer image1 = nullptr;
typename ImageType::Pointer image2 = nullptr;
@@ -1608,25 +1608,25 @@ Where(int argc, char * argv[])
ReadImage<ImageType>(image2, fn2.c_str());
}

unsigned long ct = 0;
typedef itk::ImageRegionIteratorWithIndex<ImageType> Iterator;
Iterator iter(image1, image1->GetLargestPossibleRegion());
for (iter.GoToBegin(); !iter.IsAtEnd(); ++iter)
{
if (!image2)
{
if (static_cast<float>(std::fabs(iter.Get() - value)) < tol)
{
// std::cout << iter.GetIndex() << std::endl;
ct++;
}
}
else if (image2->GetPixel(iter.GetIndex()) > 0 && static_cast<float>(fabs(iter.Get() - value)) < tol)
{
// std::cout << iter.GetIndex() << std::endl;
ct++;
}
}
// unsigned long ct = 0;
// typedef itk::ImageRegionIteratorWithIndex<ImageType> Iterator;
// Iterator iter(image1, image1->GetLargestPossibleRegion());
// for (iter.GoToBegin(); !iter.IsAtEnd(); ++iter)
// {
// if (!image2)
// {
// if (static_cast<float>(std::fabs(iter.Get() - value)) < tol)
// {
// // std::cout << iter.GetIndex() << std::endl;
// ct++;
// }
// }
// else if (image2->GetPixel(iter.GetIndex()) > 0 && static_cast<float>(fabs(iter.Get() - value)) < tol)
// {
// // std::cout << iter.GetIndex() << std::endl;
// ct++;
// }
// }
// std::cout << ct << " voxels have the value " << value << std::endl;
return 0;
}
@@ -3739,8 +3739,8 @@ TimeSeriesToMatrix(int argc, char * argv[])
}
SliceIt vfIter2(outimage, outimage->GetLargestPossibleRegion());
voxct = 0;
PixelType meanval = 0;
unsigned long fullct = 0;
// PixelType meanval = 0;
// unsigned long fullct = 0;
for (vfIter2.GoToBegin(); !vfIter2.IsAtEnd(); ++vfIter2)
{
OutIndexType ind = vfIter2.GetIndex();
@@ -3767,8 +3767,8 @@ TimeSeriesToMatrix(int argc, char * argv[])
{
matriximage->SetPixel(matind, pix);
}
meanval += static_cast<PixelType>(pix);
fullct++;
// meanval += static_cast<PixelType>(pix);
// fullct++;
}
std::string colname = std::string("V") + ants_to_string<unsigned int>(voxct);
ColumnHeaders.push_back(colname);
@@ -6600,25 +6600,25 @@ CompareHeadersAndImages(int argc, char * argv[])

// compute error in spacing, in orientation and in offset
unsigned int failure = 0;
float sperr = 0, merr = 0, operr = 0, orsignerr = 0;
float merr = 0, orsignerr = 0;

typename ImageType::SpacingType sp1, sp2;
sp1 = image1->GetSpacing();
sp2 = image2->GetSpacing();
for (unsigned int i = 0; i < ImageDimension; i++)
{
float temp = sp1[i] - sp2[i];
sperr += temp * temp;
}
// for (unsigned int i = 0; i < ImageDimension; i++)
// {
// float temp = sp1[i] - sp2[i];
// sperr += temp * temp;
// }
// std::cout << " SpacingError: " << sqrt(sperr) << std::endl;

typename ImageType::PointType op1, op2;
op1 = image1->GetOrigin();
op2 = image2->GetOrigin();
for (unsigned int i = 0; i < ImageDimension; i++)
{
float temp = op1[i] - op2[i];
operr += temp * temp;
// float temp = op1[i] - op2[i];
// operr += temp * temp;
if (op1[i] > 0 && op2[i] <= 0)
{
orsignerr += 1;
@@ -6703,8 +6703,8 @@ CompareHeadersAndImages(int argc, char * argv[])
resample->UpdateLargestPossibleRegion();
typename ImageType::Pointer varimage = resample->GetOutput();
}
float i1norm = 0, i2norm = 0, i1i2norm = 0; // i3norm=0,i1i3norm=0;
unsigned long ct1 = 1, ct2 = 1, ct12 = 1; // ct3=1,ct13=1;
float i1norm = 0, i2norm = 0; // i3norm=0,i1i3norm=0;
unsigned long ct1 = 1, ct2 = 1; // ct3=1,ct13=1;
Iterator vfIter2(image1, image1->GetLargestPossibleRegion());
for (vfIter2.GoToBegin(); !vfIter2.IsAtEnd(); ++vfIter2)
{
@@ -6747,32 +6747,32 @@ CompareHeadersAndImages(int argc, char * argv[])
{
mean2 = 1;
}
for (vfIter2.GoToBegin(); !vfIter2.IsAtEnd(); ++vfIter2)
{
IndexType ind = vfIter2.GetIndex();
float pix2;
if (isfloat)
{
pix2 = floatval;
}
else
{
pix2 = image2->GetPixel(ind) / mean2;
}
// for (vfIter2.GoToBegin(); !vfIter2.IsAtEnd(); ++vfIter2)
// {
// IndexType ind = vfIter2.GetIndex();
// float pix2;
// if (isfloat)
// {
// pix2 = floatval;
// }
// else
// {
// pix2 = image2->GetPixel(ind) / mean2;
// }
// float pix3=vfIter2.Get()/mean2;
float pix1 = image1->GetPixel(ind) / mean1;
// float pix1 = image1->GetPixel(ind) / mean1;

if (pix1 > 0 || pix2 > 0)
{
i1i2norm += static_cast<float>(std::fabs(pix1 - pix2));
ct12++;
}
// if (pix1 > 0 || pix2 > 0)
// {
// i1i2norm += static_cast<float>(std::fabs(pix1 - pix2));
// ct12++;
// }
// if ( pix1 > 0 || pix3 > 0)
// {
// i1i3norm+=fabs(pix1-pix3);
// ct13++;
// }
}
// }
// float idice1 = 1.0 - 2.0*i1i3norm/ct13 / ( i1norm/ct1 + i3norm / ct3 );
// std::cout << " DiceImageDifference: " << idice0 << " IntensityDifference: " << i1i2norm << std::endl;
// std::cout << " CenterOfMassTransImageDifference: " << idice1 << " and " << i1i3norm << std::endl;
@@ -8339,7 +8339,7 @@ FastMarchingExtension(int argc, char * argv[])
seeds->Initialize();
typename NodePairContainerType::Pointer alivePoints = NodePairContainerType::New();
alivePoints->Initialize();
unsigned int seedct = 0, alivect = 0;
// unsigned int seedct = 0, alivect = 0;
Iterator vfIter2(labimage, labimage->GetLargestPossibleRegion());
for (vfIter2.GoToBegin(); !vfIter2.IsAtEnd(); ++vfIter2)
{
@@ -8352,15 +8352,15 @@ FastMarchingExtension(int argc, char * argv[])
AuxValueVectorType vector;
vector[0] = valimage->GetPixel(ind);
auxTrialValues->push_back(vector);
seedct++;
// seedct++;
}
if ((labval > 0) && ((unsigned int)contourval != 1))
{
alivePoints->push_back(NodePairType(ind, 0.));
AuxValueVectorType vector;
vector[0] = valimage->GetPixel(ind);
auxAliveValues->push_back(vector);
alivect++;
// alivect++;
}
}
fastMarching->SetTrialPoints(seeds);
@@ -8734,17 +8734,17 @@ FillHoles(int argc, char * argv[])
GHood.GoToBegin();

unsigned long objectedge = 0;
unsigned long backgroundedge = 0;
// unsigned long backgroundedge = 0;
unsigned long totaledge = 0;
unsigned long volume = 0;
// unsigned long volume = 0;

while (!GHood.IsAtEnd())
{
typename ImageType::PixelType p = GHood.GetCenterPixel();
typename ImageType::IndexType ind2;
if (itk::Math::FloatAlmostEqual(p, static_cast<float>(lab)))
{
volume++;
// volume++;
for (unsigned int i = 0; i < GHood.Size(); i++)
{
ind2 = GHood.GetIndex(i);
@@ -8756,7 +8756,7 @@ FillHoles(int argc, char * argv[])
}
else if (val2 < 0.5f && !itk::Math::FloatAlmostEqual(GHood.GetPixel(i), static_cast<float>(lab)))
{
backgroundedge++;
// backgroundedge++;
totaledge++;
}
}
@@ -10717,12 +10717,12 @@ LabelThickness(int argc, char * argv[])
}

std::sort(myLabelSet.begin(), myLabelSet.end());
typename LabelSetType::const_iterator it;
unsigned long labelcount = 0;
for (it = myLabelSet.begin(); it != myLabelSet.end(); ++it)
{
labelcount++;
}
// typename LabelSetType::const_iterator it;
// unsigned long labelcount = 0;
// for (it = myLabelSet.begin(); it != myLabelSet.end(); ++it)
// {
// labelcount++;
// }

typename ImageType::SpacingType spacing = image->GetSpacing();
float volumeelement = 1.0;
@@ -11681,14 +11681,14 @@ ConvertImageSetToEigenvectors(unsigned int argc, char * argv[])
for (unsigned long mv = 1; mv <= maxval; mv++)
{
/** 2. count the voxels in this label */
unsigned long voxct = 0;
for (Iterator mIter(mask, mask->GetLargestPossibleRegion()); !mIter.IsAtEnd(); ++mIter)
{
if (itk::Math::FloatAlmostEqual(mIter.Get(), static_cast<float>(mv)))
{
voxct++;
}
}
// unsigned long voxct = 0;
// for (Iterator mIter(mask, mask->GetLargestPossibleRegion()); !mIter.IsAtEnd(); ++mIter)
// {
// if (itk::Math::FloatAlmostEqual(mIter.Get(), static_cast<float>(mv)))
// {
// voxct++;
// }
// }

unsigned long xx1 = 0, yy1 = 0;
if (rowcoloption == 0)
@@ -13706,15 +13706,15 @@ getBlobCorrespondenceMatrix(unsigned int radval,
BlobPointer bestblob = nullptr;
if ((!blobs2.empty()) && (!blobs1.empty()))
{
unsigned int count2;
// unsigned int count2;
RealType smallval = 1.e-4;
typedef itk::LinearInterpolateImageFunction<ImageType, float> ScalarInterpolatorType;
typedef typename ScalarInterpolatorType::Pointer InterpPointer;
InterpPointer interp1 = ScalarInterpolatorType::New();
interp1->SetInputImage(image);
InterpPointer interp2 = ScalarInterpolatorType::New();
interp2->SetInputImage(image2);
unsigned int count1 = 0;
// unsigned int count1 = 0;
for (unsigned int i = 0; i < blobs1.size(); i++)
{
BlobPointer blob1 = blobs1[i];
@@ -13723,7 +13723,7 @@ getBlobCorrespondenceMatrix(unsigned int radval,
{
GHood.SetLocation(indexi);
bestblob = nullptr;
count2 = 0;
// count2 = 0;
for (unsigned int j = 0; j < blobs2.size(); j++)
{
const BlobPointer & blob2 = blobs2[j];
@@ -13739,10 +13739,10 @@ getBlobCorrespondenceMatrix(unsigned int radval,
correlation = 0;
}
correspondencematrix(i, j) = correlation;
count2++;
// count2++;
}
}
count1++;
// count1++;
} // imagei GetPixel gt 0
if (i % 100 == 0)
{
@@ -14141,7 +14141,7 @@ MatchBlobs(int argc, char * argv[])
unsigned int matchpt = 1;
std::cout << " now compute pairwise matching " << correspondencematrix.max_value() << " reducing to " << corrthresh
<< std::endl;
unsigned int count1 = 0;
// unsigned int count1 = 0;
typedef std::pair<BlobPointer, BlobPointer> BlobPairType;
std::vector<BlobPairType> blobpairs;
vnl_matrix<RealType> correspondencematrix_hard(correspondencematrix);
@@ -14176,7 +14176,7 @@ MatchBlobs(int argc, char * argv[])
correspondencematrix_hard.set_row(maxrow, correspondencematrix_hard.get_row(maxrow).fill(0));
correspondencematrix_hard.set_column(maxcol, correspondencematrix_hard.get_column(maxcol).fill(0));
correspondencematrix_soft(maxrow, maxcol) = 0;
count1++;
// count1++;
}

/** For every blob, compute the distance to its neighbors before and after matching */
4 changes: 2 additions & 2 deletions Utilities/antsSCCANObject.h
Original file line number Diff line number Diff line change
@@ -1249,12 +1249,12 @@ for ( unsigned int j = 0 ; j < b.rows(); j++ ) mat( i , j ) = invamat( i , j );
RPearsonCorr(VectorType v1, VectorType v2)
{
std::vector<TRealType> zeromatch(v1.size(), 0);
unsigned int zct = 0;

for (unsigned int zm = 0; zm < v1.size(); zm++)
{
if ((this->Close2Zero(v1(zm)) || this->Close2Zero(v2(zm))))
{
zct++;

zeromatch[zm] = 1;
v1(zm) = 0;
v2(zm) = 0;
26 changes: 13 additions & 13 deletions Utilities/antsSCCANObject.hxx
Original file line number Diff line number Diff line change
@@ -111,7 +111,7 @@ antsSCCANObject<TInputImage, TRealType>::ConvertVariateToSpatialImage(
vecind = 0;
for (unsigned int k = 0; k < this->m_VecToMaskSize; k++) // loop begin
{
unsigned long maskct = 0;
// unsigned long maskct = 0;
for (mIter.GoToBegin(); !mIter.IsAtEnd(); ++mIter)
{
if (mIter.Get() >= static_cast<typename TInputImage::PixelType>(0.5))
@@ -141,7 +141,7 @@ antsSCCANObject<TInputImage, TRealType>::ConvertVariateToSpatialImage(
vecind++;
// if ( maskct % 289 == 0 ) if ( ! this->m_Silent ) std::cout << "k "<< k << " mval " << val << " w " << w_p(
// vecind ) << std::endl;
maskct++;
// maskct++;
}
else
{
@@ -258,7 +258,7 @@ antsSCCANObject<TInputImage, TRealType>::CurvatureSparseness(
RealType kappa = 20;
RealType lastkappa = 20;
unsigned int kkk = 0;
unsigned int zct = 0;
// unsigned int zct = 0;
RealType dkappa = 1;
RealType sp = 0;
bool notdone = true;
@@ -275,7 +275,7 @@ antsSCCANObject<TInputImage, TRealType>::CurvatureSparseness(
if (((x[kk] > 0) && (signvec[kk] < 0)) || ((x[kk] < 0) && (signvec[kk] > 0)))
{
x[kk] = 0;
zct++;
// zct++;
}
else if (itk::Math::abs(x[kk]) > 1.e-6)
{
@@ -286,7 +286,7 @@ antsSCCANObject<TInputImage, TRealType>::CurvatureSparseness(
else
{
x[kk] = 0;
zct++;
// zct++;
}
}
if (nzct > 0)
@@ -399,7 +399,7 @@ antsSCCANObject<TInputImage, TRealType>::ClusterThresholdVariate(
// iterate through the image and set the voxels where countinlabel[(unsigned
// long)(labelimage->GetPixel(vfIter.GetIndex()) - min)]
// is < MinClusterSize
unsigned long vecind = 0, keepct = 0;
unsigned long vecind = 0; // , keepct = 0;
for (unsigned int k = 0; k < this->m_VecToMaskSize; k++)
{
fIterator mIter(mask, mask->GetLargestPossibleRegion());
@@ -414,7 +414,7 @@ antsSCCANObject<TInputImage, TRealType>::ClusterThresholdVariate(
clustersize = histogram[(unsigned long)(relabel->GetOutput()->GetPixel(mIter.GetIndex()))];
if (clustersize > minclust)
{
keepct += 1;
// keepct += 1;
} // get clusters > minclust
// if ( clustersize == largest_component_size ) { keepct++; } // get largest cluster
else
@@ -582,7 +582,7 @@ antsSCCANObject<TInputImage, TRealType>::ConvertImageToVariate(typename TInputIm
ULPixelType maskct2 = 0;
for (unsigned int k = 0; k < this->m_VecToMaskSize; k++) // loop begin
{
ULPixelType maskctbase = 0;
// ULPixelType maskctbase = 0;
for (vfIter.GoToBegin(); !vfIter.IsAtEnd(); ++vfIter)
{
RealType maskval = vfIter.Get();
@@ -591,7 +591,7 @@ antsSCCANObject<TInputImage, TRealType>::ConvertImageToVariate(typename TInputIm
{
vec[maskct2] = imageval;
maskct2++;
maskctbase++;
// maskctbase++;
}
}
}
@@ -637,7 +637,7 @@ antsSCCANObject<TInputImage, TRealType>::ConvertImageToVariate4D(typename TInput
ULPixelType maskct2 = 0;
for (unsigned int k = 0; k < this->m_VecToMaskSize; k++) // loop begin
{
ULPixelType maskctbase = 0;
// ULPixelType maskctbase = 0;
for (vfIter.GoToBegin(); !vfIter.IsAtEnd(); ++vfIter)
{
RealType maskval = vfIter.Get();
@@ -650,7 +650,7 @@ antsSCCANObject<TInputImage, TRealType>::ConvertImageToVariate4D(typename TInput
ind4d[ImageDimension - 1] = k;
vec[maskct2] = image->GetPixel(ind4d);
maskct2++;
maskctbase++;
// maskctbase++;
}
}
}
@@ -5282,12 +5282,12 @@ antsSCCANObject<TInputImage, TRealType>::CCAUpdate(unsigned int n_vecs,
this->SparsifyOther(qveck); // zeromatch
// get list of all zeroes
std::vector<TRealType> zeromatch(qveck.size(), 0);
unsigned int zct = 0;
// unsigned int zct = 0;
for (unsigned int zm = 0; zm < qveck.size(); zm++)
{
if ((this->Close2Zero(pveck(zm)) || this->Close2Zero(qveck(zm))) && (false))
{
zct++;
// zct++;
zeromatch[zm] = 1;
pveck(zm) = 0;
qveck(zm) = 0;
8 changes: 4 additions & 4 deletions Utilities/itkSurfaceCurvatureBase.hxx
Original file line number Diff line number Diff line change
@@ -506,7 +506,7 @@ SurfaceCurvatureBase<TSurface, TDimension>::ComputeJoshiFrame(PointType origin)

D.set_size(npts, 3);
D.fill(0.0);
float totw = 0;
// float totw = 0;
for (unsigned int i = 0; i < npts; i++)
{
PointType Q = m_PointList[i];
@@ -520,7 +520,7 @@ SurfaceCurvatureBase<TSurface, TDimension>::ComputeJoshiFrame(PointType origin)
u2 += (Q[ijj] - origin[ijj]) * m_Tangent2[ijj];
sqdif += ((Q[ijj] - origin[ijj]) * (Q[ijj] - origin[ijj]));
}
totw += 1.0f / sqdif;
// totw += 1.0f / sqdif;
//
// co-ordinates in tangent plane
// RealType sign=1.0;
@@ -1250,7 +1250,7 @@ SurfaceCurvatureBase<TSurface, TDimension>::dstarUestimate()
D.set_size(npts, 3); // each row contains [ u, v, 1] for point p
D.fill(0.0);

float totwt = 0.0;
// float totwt = 0.0;
float totfunc = 0.0;
float wt = 0.0;
float meanu1 = 0;
@@ -1268,7 +1268,7 @@ SurfaceCurvatureBase<TSurface, TDimension>::dstarUestimate()
float u2 = 0.0;
wt = Dif.magnitude();
wts[i] = wt;
totwt += wt;
// totwt += wt;
for (unsigned int pp = 0; pp < SurfaceDimension; pp++)
{
u1 += Dif[pp] * m_Tangent1[pp];
16 changes: 8 additions & 8 deletions Utilities/itkSurfaceImageCurvature.hxx
Original file line number Diff line number Diff line change
@@ -849,7 +849,7 @@ SurfaceImageCurvature<TSurface>::IntegrateFunctionOverSurface(bool norm)

this->m_ti.Initialize(rad, this->GetInput(), image->GetLargestPossibleRegion());
this->m_ti2.Initialize(rad2, this->GetInput(), image->GetLargestPossibleRegion());
unsigned long ct = 0;
// unsigned long ct = 0;

IndexType index;

@@ -869,7 +869,7 @@ SurfaceImageCurvature<TSurface>::IntegrateFunctionOverSurface(bool norm)
index[2] > this->m_NeighborhoodRadius)
{
PointType p;
ct++;
// ct++;
for (unsigned int k = 0; k < ImageDimension; k++)
{
p[k] = (RealType)index[k];
@@ -1037,10 +1037,10 @@ SurfaceImageCurvature<TSurface>::ComputeFrameOverDomain(unsigned int which)
// Get Normals First!
this->EstimateNormalsFromGradient();

unsigned int ct = 1;
unsigned long ct2 = 0;
// unsigned int ct = 1;
// unsigned long ct2 = 0;
RealType kpix = 0;
double thresh = 0.0;
// double thresh = 0.0;


ti.GoToBegin();
@@ -1149,18 +1149,18 @@ SurfaceImageCurvature<TSurface>::ComputeFrameOverDomain(unsigned int which)
{
kpix = this->m_Area;
}
ct++;
// ct++;
this->m_PointList.clear();
}
thresh += static_cast<double>(kpix);
// thresh += static_cast<double>(kpix);
float offset = 0;
if (which == 5)
{
offset = 0;
}
// if ( () && ( ) ) kpix=0;
this->m_FunctionImage->SetPixel(index, offset + kpix);
ct2++;
// ct2++;
++ti;
}
}

0 comments on commit 8f25651

Please sign in to comment.