Misc. typos

Found via `codespell`
This commit is contained in:
luz.paz 2018-10-03 14:51:13 -04:00 committed by luz paz
parent db1b394336
commit d5beb69ec1
35 changed files with 55 additions and 55 deletions

@ -102,7 +102,7 @@ if(VTKM_COMPILER_IS_MSVC)
target_compile_definitions(vtkm_developer_flags INTERFACE "_SCL_SECURE_NO_WARNINGS"
"_CRT_SECURE_NO_WARNINGS")
#CMake COMPILE_LANGUAGE doesn't work with MSVC, ans since we want these flags
#CMake COMPILE_LANGUAGE doesn't work with MSVC, and since we want these flags
#only for C++ compilation we have to resort to setting CMAKE_CXX_FLAGS :(
set(CMAKE_CXX_FLAGS "${CMAKE_CXX_FLAGS} /wd4702 /wd4505")
set(CMAKE_CUDA_FLAGS "${CMAKE_CUDA_FLAGS} -Xcompiler=\"/wd4702 /wd4505\" -Xcudafe=\"--diag_suppress=1394 --diag_suppress=766 --display_error_number\"")

@ -326,7 +326,7 @@ public:
catch (std::exception& e)
{
std::cout << "\n"
<< "An exception occuring during a benchmark:\n\t" << e.what() << "\n"
<< "An exception occurring during a benchmark:\n\t" << e.what() << "\n"
<< "Attempting to continue with remaining benchmarks...\n\n";
}
}

@ -1,7 +1,7 @@
# Worklets are now asynchronous in Cuda
Worklets are now fully asynchronous in the cuda backend. This means that
worklet errors are reported asynchonously. Existing errors are checked for
worklet errors are reported asynchronously. Existing errors are checked for
before invocation of a new worklet and at explicit synchronization points like
`DeviceAdapterAlgorithm<>::Synchronize()`.

@ -27,7 +27,7 @@ demonstrated/tested in `vtkm/testing/TestingGeometry.h`:
+ `Sphere<CoordType, Dimension>`.
Instances of this struct represent a *d*-dimensional sphere.
Its state is the coordinates of its center plus a radius.
It is also aliased with a `using` statment to `Circle<CoordType>`
It is also aliased with a `using` statement to `Circle<CoordType>`
for the specific case of 2-D.
These structures provide useful queries and generally

@ -1,6 +1,6 @@
#Interfaces for VTK-m spatial search strucutres added
#Interfaces for VTK-m spatial search structures added
The objective for this feature was to add a commom interface for the VTK-m
The objective for this feature was to add a common interface for the VTK-m
spatial search strucutes for ease of use for the users.
VTK-m now distinguishes locators into two types, cell locators and point
locators. Cell locators can be used to query a containing cell for a point,
@ -16,7 +16,7 @@ a cell locator, or a point locator and provided an easy way to use them in the
execution environment.
By deriving new search structures from these locator interfaces, it makes it
easier for users to build the underlying strucutres as well, abstracting away
easier for users to build the underlying structures as well, abstracting away
complicated details. After providing all the required data from a
`vtkm::cont::DataSet` object, the user only need to call the `Update` method
on the object of `vtkm::cont::CellLocator`, or `vtkm::cont::PointLocator`.

@ -1,7 +1,7 @@
# Add a warp vector worklet and filter
This commit adds a worklet that modifies point coordinates by moving points
along point normals by the scalar amount. It's a simpified version of the
along point normals by the scalar amount. It's a simplified version of the
vtkWarpScalar in VTK. Additionally the filter doesn't modify the point coordinates,
but creates a new point coordinates that have been warped.
Useful for showing flow profiles or mechanical deformation.

@ -2,6 +2,6 @@ Add a warpScalar worklet and filter
This commit adds a worklet as well as a filter that modify point coordinates by moving points
along point normals by the scalar amount times the scalar factor.
It's a simpified version of the vtkWarpScalar class in VTK. Additionally the filter doesn't
It's a simplified version of the vtkWarpScalar class in VTK. Additionally the filter doesn't
modify the point coordinates, but creates a new point coordinates that have been warped.

@ -205,7 +205,7 @@ int main(int argc, char* argv[])
<< std::endl;
std::cout << "--printCT Print the contour tree. (Default=False)" << std::endl;
#ifdef ENABLE_SET_NUM_THREADS
std::cout << "--numThreads Specifiy the number of threads to use. Available only with TBB."
std::cout << "--numThreads Specify the number of threads to use. Available only with TBB."
<< std::endl;
#endif
return 0;

@ -164,7 +164,7 @@ public:
this->Array.ReleaseResources();
}
// Requried for later use in ArrayTransfer class.
// Required for later use in ArrayTransfer class.
VTKM_CONT
const ArrayHandleType& GetArray() const
{

@ -118,7 +118,7 @@ void parallel_sort_bykey(vtkm::cont::ArrayHandle<T, StorageT>& keys,
openmp::CopyHelper(inputPortal, outputPortal, 0, 0, keys.GetNumberOfValues());
}
// Sort the keys and indicies:
// Sort the keys and indices:
ZipHandleType zipHandle = vtkm::cont::make_ArrayHandleZip(keys, indexArray);
parallel_sort(zipHandle,
vtkm::cont::internal::KeyCompare<T, vtkm::Id, BinaryCompare>(binary_compare),

@ -2036,7 +2036,7 @@ private:
VTKM_TEST_ASSERT(message == ERROR_MESSAGE, "Did not get expected error message.");
// This is spcifically to test the cuda-backend but should pass for all backends
std::cout << "Testing if execution errors are eventually propogated to the host "
std::cout << "Testing if execution errors are eventually propagated to the host "
<< "without explicit synchronization\n";
message = "";
int nkernels = 0;

@ -370,7 +370,7 @@ void ColorTableBase::FindColors(double value,
rgb2 = this->NaNColor;
}
else if (this->ColorSize == 0)
{ //If we have no entires use the below range value
{ //If we have no entries use the below range value
rgb1 = this->BelowRangeColor;
rgb2 = this->BelowRangeColor;
}

@ -103,7 +103,7 @@ private:
bool ComputeRegularStructure;
std::vector<std::pair<std::string, vtkm::Float64>> Timings;
// TODO Should the additional fields below be addd to the vtkm::filter::ResultField and what is the best way to represent them
// TODO Should the additional fields below be add to the vtkm::filter::ResultField and what is the best way to represent them
// Additional result fields not included in the vtkm::filter::ResultField returned by DoExecute
vtkm::worklet::contourtree_augmented::ContourTree ContourTreeData; // The contour tree
vtkm::Id NumIterations; // Number of iterations used to compute the contour tree

@ -264,7 +264,7 @@ inline VTKM_CONT vtkm::cont::DataSet Lagrangian::DoExecute(
RectilinearGridEvalType eval(coords, cells, field);
RK4IntegratorType rk4(eval, static_cast<vtkm::Float32>(this->stepSize));
/*
* If Euler step is preffered.
* If Euler step is preferred.
EulerIntegratorType euler(eval, static_cast<vtkm::FloatDefault>(this->stepSize));
*/
res = particleadvection.Run(rk4, basisParticleArray, 1, device); // Taking a single step

@ -409,7 +409,7 @@ private:
IdPortalType ParentPortal;
vtkm::Id LeafCount;
vtkm::Id InnerCount;
//TODO: get instrinsic support
//TODO: get intrinsic support
VTKM_EXEC
inline vtkm::Int32 CountLeadingZeros(vtkm::UInt32& x) const
{
@ -511,7 +511,7 @@ public:
vtkm::Int32 deltaNode = delta(idx, j);
vtkm::Int32 s = 0;
vtkm::Float32 divFactor = 2.f;
//find the split postition using a binary search
//find the split position using a binary search
for (vtkm::Int32 t = (vtkm::Int32)ceil(vtkm::Float32(l) / divFactor);;
divFactor *= 2, t = (vtkm::Int32)ceil(vtkm::Float32(l) / divFactor))
{

@ -310,7 +310,7 @@ VTKM_CONT MeshConnHandle make_MeshConnHandle(MeshConnType&& func,
#ifdef VTKM_CUDA
// Cuda seems to have a bug where it expects the template class VirtualObjectTransfer
// to be instantiated in a consitent order among all the translation units of an
// to be instantiated in a consistent order among all the translation units of an
// executable. Failing to do so results in random crashes and incorrect results.
// We workaroud this issue by explicitly instantiating VirtualObjectTransfer for
// all the implicit functions here.

@ -233,7 +233,7 @@ public:
}
//this means that this cell is responsible for both itself and the other cell
//set the connecttion for the other cell
//set the connection for the other cell
if (isInternal)
{
BOUNDS_CHECK(faceIdPairs, index);
@ -394,7 +394,7 @@ public:
};
//
// We get one index per extenal face
// We get one index per external face
//
//
@ -421,7 +421,7 @@ public:
// For each face, we will have a relative offset to
// the "bottom corner of the face. Three are at the
// origin. and we have to ajust for the other faces.
// origin. and we have to adjust for the other faces.
vtkm::Id3 cellIndex(0, 0, 0);
if (cellFace == 1)
cellIndex[0] = CellDims[0] - 1;
@ -702,7 +702,7 @@ void MeshConnectivityBuilder::BuildConnectivity(
FaceOffsets);
vtkm::cont::ArrayHandle<vtkm::Vec<vtkm::Id, 4>> externalTriangles;
//Extenal Faces
//External Faces
externalTriangles =
ExtractExternalFaces(cellFaceId, faceConnectivity, shapes, conn, shapeOffsets);
@ -761,7 +761,7 @@ void MeshConnectivityBuilder::BuildConnectivity(
vtkm::cont::ArrayHandle<vtkm::Vec<vtkm::Id, 4>> externalTriangles;
//
//Extenal Faces
//External Faces
externalTriangles =
ExtractExternalFaces(cellFaceId, faceConnectivity, shapes, conn, shapeOffsets);

@ -1187,7 +1187,7 @@ struct ConvertToInt {
template <> \
struct ConvertToInt<Type> { enum { value = 0 }; }
// Silence warnings about convering float to int.
// Silence warnings about converting float to int.
FMT_DISABLE_CONVERSION_TO_INT(float);
FMT_DISABLE_CONVERSION_TO_INT(double);
FMT_DISABLE_CONVERSION_TO_INT(long double);

@ -195,8 +195,8 @@ private:
// Start the timer
vtkm::cont::Timer<DeviceAdapter> totalTime;
// Stage 1: Load the data into the mesh. This is done in the Run() method above and accesible
// here via the mesh parameter. The actual data load is perfomed outside of the
// Stage 1: Load the data into the mesh. This is done in the Run() method above and accessible
// here via the mesh parameter. The actual data load is performed outside of the
// worklet in the example contour tree app (or whoever uses the worklet)
// Stage 2 : Sort the data on the mesh to initialize sortIndex & indexReverse on the mesh

@ -58,7 +58,7 @@ public:
// 1 indicates marginal variable, otherwise 0.
// conditionFunc: The Condition function for non-marginal variable.
// This func takes two arguments (vtkm::Id var, vtkm::Id binId) and return bool
// var is index of variable and binId is bin index in the varaiable var
// var is index of variable and binId is bin index in the variable var
// return true indicates considering this bin into final marginal histogram
// more details can refer to example in UnitTestNDimsHistMarginalization.cxx
// marginalBinId, marginalFreqs: return marginalized histogram in the fashion of sparse representation

@ -257,7 +257,7 @@ void ActiveGraph::Initialise(Mesh& mesh, const MeshExtrema& meshExtrema)
IdArrayType outDegrees; // TODO Should we change this to an unsigned type
outDegrees.Allocate(mesh.nVertices);
// Initalize the nerighborhoodMasks and outDegrees arrays
// Initialize the nerighborhoodMasks and outDegrees arrays
mesh.setPrepareForExecutionBehavior(isJoinGraph);
active_graph_inc_ns::InitializeNeighbourhoodMasksAndOutDegrees initNeighMasksAndOutDegWorklet(
isJoinGraph);
@ -469,7 +469,7 @@ void ActiveGraph::TransferSaddleStarts()
// std::partial_sum(vtkm::cont::ArrayPortalToIteratorBegin(newOutdegree.GetPortalControl()),
// vtkm::cont::ArrayPortalToIteratorEnd(newOutdegree.GetPortalControl()) - 1,
// vtkm::cont::ArrayPortalToIteratorBegin(newFirstEdge.GetPortalControl()) + 1);
// VTK:M verison of the prefix sum
// VTK:M version of the prefix sum
vtkm::cont::Algorithm::ScanExclusive(this->Invoke.GetDevice(), newOutdegree, newFirstEdge);
vtkm::Id nEdgesToSort = 0;

@ -105,7 +105,7 @@ void permuteArray(vtkm::cont::DeviceAdapterId device,
output.Shrink(permNumValues);
} // else the output has already the correct size
// The following is equivilant to doing the following in serial
// The following is equivalent to doing the following in serial
//
// for (vtkm::Id entry = 0; entry < permute.size(); entry++)
// output[entry] = input[maskedIndex(permute[entry])];
@ -121,13 +121,13 @@ void permuteArray(vtkm::cont::DeviceAdapterId device,
vtkm::cont::Algorithm::Copy(device, permutedInput, output);
} // permuteValues()
// permuteValues from the orignial PPP2 code is equivilant to permuteArray<T, vtkm::cont:ArrayHandle<T, StorageType>, DeviceAdaptor> and has therefore been removed
// permuteValues from the original PPP2 code is equivalent to permuteArray<T, vtkm::cont:ArrayHandle<T, StorageType>, DeviceAdaptor> and has therefore been removed
/*template <typename T, typename StorageType, typename DeviceAdapter>
void permuteValues(const vtkm::cont::ArrayHandle<T,StorageType> &input, IdArrayType &permute, vtkm::cont::ArrayHandle<T,StorageType> &output)
{}
*/
// permuteIndicies from the original PPP2 code is equivilant to permuteArray<vtkm::Id, IdArrayType, DeviceAdaptor> and has therefore been removed
// permuteIndicies from the original PPP2 code is equivalent to permuteArray<vtkm::Id, IdArrayType, DeviceAdaptor> and has therefore been removed
/* template <typename DeviceAdapter>
void permuteIndices(IdArrayType &input, IdArrayType &permute, IdArrayType &output)
{}

@ -288,7 +288,7 @@ void ContourTreeMaker::ComputeHyperAndSuperStructure()
// now we establish the reverse index array
IdArrayType superSortIndex;
superSortIndex.Allocate(contourTree.supernodes.GetNumberOfValues());
// The following copy is equivilant to
// The following copy is equivalent to
// for (vtkm::Id supernode = 0; supernode < contourTree.supernodes.size(); supernode++)
// superSortIndex[contourTree.hypernodes[supernode]] = supernode;
@ -399,7 +399,7 @@ void ContourTreeMaker::ComputeHyperAndSuperStructure()
// now reuse the superSortIndex array for hypernode IDs
// The following copy is equivilant to
// The following copy is equivalent to
// for (vtkm::Id hypernode = 0; hypernode < contourTree.hypernodes.size(); hypernode++)
// superSortIndex[contourTree.hypernodes[hypernode]] = hypernode;
// source data array is a simple linear index from 0 to #hypernodes
@ -450,7 +450,7 @@ void ContourTreeMaker::ComputeRegularStructure(MeshExtrema& meshExtrema)
{ // ComputeRegularStructure()
// First step - use the superstructure to set the superparent for all supernodes
auto supernodesIndex = vtkm::cont::ArrayHandleIndex(
contourTree.supernodes.GetNumberOfValues()); // Counting array of lenght #supernodes to
contourTree.supernodes.GetNumberOfValues()); // Counting array of length #supernodes to
auto permutedSuperparents = vtkm::cont::make_ArrayHandlePermutation(
contourTree.supernodes,
contourTree.superparents); // superparents array permmuted by the supernodes array
@ -651,7 +651,7 @@ void ContourTreeMaker::AugmentMergeTrees()
vtkm::cont::Algorithm::Copy(device, noSuchElementArray, contourTree.hyperarcs);
vtkm::cont::Algorithm::Copy(device, noSuchElementArray, contourTree.whenTransferred);
// TODO We should only need to allocate the updegree/downdegree arrays. We initalize them with 0 here to ensure consistency of debug output
// TODO We should only need to allocate the updegree/downdegree arrays. We initialize them with 0 here to ensure consistency of debug output
//updegree.Allocate(nSupernodes);
//downdegree.Allocate(nSupernodes);
vtkm::cont::Algorithm::Copy(
@ -718,7 +718,7 @@ struct LeafChainsToContourTree
void ContourTreeMaker::TransferLeafChains(bool isJoin)
{ // ContourTreeMaker::TransferLeafChains()
// we need to compute the chains in both directions, so we have two vectors:
// TODO below we initalize the outbound and inbound arrays with 0 to ensure consistency of debug output. Check if this is needed.
// TODO below we initialize the outbound and inbound arrays with 0 to ensure consistency of debug output. Check if this is needed.
IdArrayType outbound;
vtkm::cont::Algorithm::Copy(
this->Invoke.GetDevice(),
@ -853,7 +853,7 @@ void ContourTreeMaker::CompressActiveSupernodes()
// Permute the wasNotTransferred array handle so that the lookup is based on the value of the indices in the active supernodes array
auto notTransferredActiveSupernodes =
vtkm::cont::make_ArrayHandlePermutation(activeSupernodes, wasNotTransferred);
// Keep only the indicies of the active supernodes that have not been transferred yet
// Keep only the indices of the active supernodes that have not been transferred yet
vtkm::cont::Algorithm::CopyIf(this->Invoke.GetDevice(),
activeSupernodes,
notTransferredActiveSupernodes,

@ -130,7 +130,7 @@ inline MeshExtrema::MeshExtrema(vtkm::cont::DeviceAdapterId device, vtkm::Id mes
// Allocate memory for the peaks and pits
peaks.Allocate(nVertices);
pits.Allocate(nVertices);
// TODO Check if we really need to set the peaks and pits to zero or whether it is enough to alloate them
// TODO Check if we really need to set the peaks and pits to zero or whether it is enough to allocate them
vtkm::cont::ArrayHandleConstant<vtkm::Id> constZeroArray(0, nVertices);
vtkm::cont::Algorithm::Copy(device, constZeroArray, peaks);
vtkm::cont::Algorithm::Copy(device, constZeroArray, pits);

@ -121,7 +121,7 @@ public:
// i.e. the inverse permutation for sortOrder
IdArrayType sortIndices;
//empty contructor
//empty constructor
Mesh_DEM_Triangulation()
: nVertices(0)
, nLogSteps(0)

@ -139,7 +139,7 @@ public:
IdArrayType& branchSaddle,
IdArrayType& branchParent);
// create explicit representation of the branch decompostion from the array representation
// create explicit representation of the branch decomposition from the array representation
template <typename T, typename StorageType>
static process_contourtree_inc_ns::Branch<T>* ComputeBranchDecomposition(
const IdArrayType& contourTreeSuperparents,

@ -95,7 +95,7 @@ public:
SetSuperArcsSetTreeSuperarcs() {}
template <typename InFieldPortalType, typename OutFieldPortalType>
VTKM_EXEC void operator()(const vtkm::Id& /*graphVertex*/, // FIXME: Remove unused paramter?
VTKM_EXEC void operator()(const vtkm::Id& /*graphVertex*/, // FIXME: Remove unused parameter?
const vtkm::Id supernode,
const InFieldPortalType& hyperarcsPortal,
const InFieldPortalType& treeHyperparentsPortal,

@ -134,7 +134,7 @@ public:
template <typename OutFieldPortalType>
VTKM_EXEC void operator()(const vtkm::Id& superID,
const vtkm::Id /*activeID*/, // FIXME: Remove unsued paramter?
const vtkm::Id /*activeID*/, // FIXME: Remove unused parameter?
const OutFieldPortalType& contourTreeHyperparentsPortal,
const OutFieldPortalType& contourTreeHyperarcsPortal,
const OutFieldPortalType& contourTreeSuperarcsPortal,

@ -98,7 +98,7 @@ public:
VTKM_EXEC
inline vtkm::Id vertexRow(vtkm::Id v) const { return v / nCols; }
// verteck column -- interger modulus by columns
// verteck column -- integer modulus by columns
VTKM_EXEC
inline vtkm::Id vertexColumn(vtkm::Id v) const { return v % nCols; }

@ -100,7 +100,7 @@ public:
VTKM_EXEC
vtkm::Id vertexRow(vtkm::Id v) const { return (v % (nRows * nCols)) / nCols; }
// vertex column -- interger modulus by columns
// vertex column -- integer modulus by columns
VTKM_EXEC
vtkm::Id vertexColumn(vtkm::Id v) const { return v % nCols; }

@ -127,7 +127,7 @@ Mesh_DEM_Triangulation_3D_MarchingCubes<T, StorageType>::Mesh_DEM_Triangulation_
m3d_marchingcubes_inc_ns::N_ALL_NEIGHBOURS);
cubeVertexPermutations = vtkm::cont::make_ArrayHandleGroupVec<
m3d_marchingcubes_inc_ns::
cubeVertexPermutations_PermVecLength>( // create 2D array of vectors of lenghts ...PermVecLength
cubeVertexPermutations_PermVecLength>( // create 2D array of vectors of lengths ...PermVecLength
vtkm::cont::make_ArrayHandle(
m3d_marchingcubes_inc_ns::cubeVertexPermutations, // the array to convert
m3d_marchingcubes_inc_ns::cubeVertexPermutations_NumPermutations *
@ -135,7 +135,7 @@ Mesh_DEM_Triangulation_3D_MarchingCubes<T, StorageType>::Mesh_DEM_Triangulation_
));
linkVertexConnectionsSix = vtkm::cont::make_ArrayHandleGroupVec<
m3d_marchingcubes_inc_ns::
vertexConnections_VecLength>( // create 2D array of vectors o lenght ...VecLength
vertexConnections_VecLength>( // create 2D array of vectors o length ...VecLength
vtkm::cont::make_ArrayHandle(
m3d_marchingcubes_inc_ns::linkVertexConnectionsSix, // the array to convert
m3d_marchingcubes_inc_ns::linkVertexConnectionsSix_NumPairs *
@ -143,7 +143,7 @@ Mesh_DEM_Triangulation_3D_MarchingCubes<T, StorageType>::Mesh_DEM_Triangulation_
));
linkVertexConnectionsEighteen = vtkm::cont::make_ArrayHandleGroupVec<
m3d_marchingcubes_inc_ns::
vertexConnections_VecLength>( // create 2D array of vectors o lenght ...VecLength
vertexConnections_VecLength>( // create 2D array of vectors o length ...VecLength
vtkm::cont::make_ArrayHandle(
m3d_marchingcubes_inc_ns::linkVertexConnectionsEighteen, // the array to convert
m3d_marchingcubes_inc_ns::linkVertexConnectionsEighteen_NumPairs *

@ -106,7 +106,7 @@ public:
{
}
// Main constructure used in the code
// Main constructor used in the code
VTKM_EXEC_CONT
ExecutionObject_MeshStructure(vtkm::Id nrows,
vtkm::Id ncols,

@ -91,7 +91,7 @@ static const vtkm::Int8 leftBit = 1 << 0;
static const vtkm::Int8 rightBit = 1 << 1;
/* neighbourOffsets will be used as a 2D array of [N_INCIDENT_EDGES, 3]
* The array is flattened here to ease converstion in vtk-m
* The array is flattened here to ease conversion in vtk-m
*/
static const vtkm::IdComponent neighbourOffsets[N_INCIDENT_EDGES * 3] = {
-1, -1, -1, 0, -1, 0, -1, -1, 0, -1, 0, 0, -1, 0, -1, 0, 0, -1, 0, -1, -1,

@ -97,7 +97,7 @@ public:
typedef
typename edgeBoundaryDetectionMasksType::template ExecutionTypes<DeviceAdapter>::PortalConst
edgeBoundaryDetectionMasksPortalType;
// Sort indicies types
// Sort indices types
typedef typename cpp2_ns::IdArrayType::template ExecutionTypes<DeviceAdapter>::PortalConst
sortIndicesPortalType;
// cubeVertexPermutations types

@ -130,7 +130,7 @@ typedef typename vtkm::cont::ArrayHandleGroupVec<vtkm::cont::ArrayHandle<vtkm::I
cubeVertexPermutations_PermVecLength>
cubeVertexPermutationsType;
/* cubeVertexPermutations will be used as a 2D array of [8, 7]
* The array is flattened here to ease converstion in vtk-m
* The array is flattened here to ease conversion in vtk-m
*/
static const vtkm::IdComponent cubeVertexPermutations[cubeVertexPermutations_NumPermutations *
cubeVertexPermutations_PermVecLength] = {
@ -148,7 +148,7 @@ typedef typename vtkm::cont::ArrayHandleGroupVec<vtkm::cont::ArrayHandle<vtkm::I
vertexConnections_VecLength>
linkVertexConnectionsType;
/* linkVertexConnectionsSix[ will be used as a 2D array of [3, 3]
* The array is flattened here to ease converstion in vtk-m
* The array is flattened here to ease conversion in vtk-m
*/
static const vtkm::IdComponent linkVertexConnectionsSix[linkVertexConnectionsSix_NumPairs *
vertexConnections_VecLength] = { 0, 1, 0,
@ -157,7 +157,7 @@ static const vtkm::IdComponent linkVertexConnectionsSix[linkVertexConnectionsSix
// number of vertex connection pairs contained in linkVertexConnectionsSix
static const vtkm::UInt8 linkVertexConnectionsEighteen_NumPairs = 15;
/* linkVertexConnectionsEighteen[ will be used as a 2D array of [3, 3]
* The array is flattened here to ease converstion in vtk-m
* The array is flattened here to ease conversion in vtk-m
*/
static const vtkm::IdComponent
linkVertexConnectionsEighteen[linkVertexConnectionsEighteen_NumPairs *