Todo List

Member AbstractCardiacPde::CreateIntracellularConductivityTensor ()

#1316 Create a class defining constant tensors to be used when no fibre orientation is provided.

#1316 Create a class defining constant tensors to be used when no fibre orientation is provided.

Member AbstractCardiacPde::LoadCardiacCells (Archive &archive, const unsigned int version, std::vector< AbstractCardiacCell * > &rCells, AbstractTetrahedralMesh< ELEMENT_DIM, SPACE_DIM > *pMesh)
#1199 test this

Member AbstractCardiacPde::mDoOneCacheReplication
#1063 maybe we don't want the conventional assembly even in the first time step.

Member AbstractCardiacProblem::load (Archive &archive, const unsigned int version)

#1317 code for saving/loading mSolution is PROBLEM_DIM specific, move it into the save/load methods fo Mono and BidomainProblem

#1317 is there a reason we can't use PETSc's load/save vector functionality?

Member AbstractCardiacProblem::LoadExtraArchive (Archive &archive, unsigned version)
#1159 sanity check that the contents of p_bcc and mpBoundaryConditionsContainer match.

Member AbstractCardiacProblem::save (Archive &archive, const unsigned int version) const
#1317 code for saving/loading mSolution is PROBLEM_DIM specific, move it into the save/load methods fo Mono and BidomainProblem

Member AbstractCardiacProblem::Solve ()
#1318 the following line will deadlock if not every process throws in the Solve call

Member AbstractConvergenceTester::Converge (std::string nameOfTest)

This is a scarily long method; could do with some parts extracted?

Cover this

Member AbstractConvergenceTester::DisplayRun ()
The UseAbsoluteStimulus is temporary, while we are sorting out 3D stimulus. It is to be removed later (along with StimulusConvergenceTester)

Member AbstractIsotropicIncompressibleMaterialLaw::Get_d2W_dI1 (double I1, double I2)=0

The name of this method should not include underscores.

Member AbstractIsotropicIncompressibleMaterialLaw::Get_d2W_dI1I2 (double I1, double I2)=0

The name of this method should not include underscores.

Member AbstractIsotropicIncompressibleMaterialLaw::Get_d2W_dI2 (double I1, double I2)=0

The name of this method should not include underscores.

Member AbstractIsotropicIncompressibleMaterialLaw::Get_dW_dI1 (double I1, double I2)=0

The name of this method should not include underscores.

Member AbstractIsotropicIncompressibleMaterialLaw::Get_dW_dI2 (double I1, double I2)=0

The name of this method should not include underscores.

Member AbstractMesh::GetWidthExtremes (const unsigned &rDimension) const
#1322 use a const version of NodeIterator here

Member AbstractNonlinearAssembler::StaticSolve (Vec currentSolutionOrGuess=NULL, double currentTime=0.0, bool assembleMatrix=true)
do something sensible if assembleMatrix is false.

Member AbstractNonlinearAssembler::VerifyJacobian (double tol=1e-4)
Get more than one value at a time

Member AbstractStaticAssembler::AssembleOnElement (Element< ELEMENT_DIM, SPACE_DIM > &rElement, c_matrix< double, PROBLEM_DIM *(ELEMENT_DIM+1), PROBLEM_DIM *(ELEMENT_DIM+1) > &rAElem, c_vector< double, PROBLEM_DIM *(ELEMENT_DIM+1)> &rBElem, bool assembleVector, bool assembleMatrix)
#1320 This assumes that the Jacobian is constant on an element. This is true for linear basis functions, but not for any other type of basis function.

Member AbstractStaticAssembler::AssembleOnSurfaceElement (const BoundaryElement< ELEMENT_DIM-1, SPACE_DIM > &rSurfaceElement, c_vector< double, PROBLEM_DIM *ELEMENT_DIM > &rBSurfElem)

: add interpolation of u as well

#1321 Improve efficiency of Neumann BC implementation.

Member AbstractStaticAssembler::ComputeTransformedBasisFunctionDerivatives (const ChastePoint< ELEMENT_DIM > &rPoint, const c_matrix< double, ELEMENT_DIM, SPACE_DIM > &rInverseJacobian, c_matrix< double, SPACE_DIM, ELEMENT_DIM+1 > &rReturnValue)

#1319 Template LinearBasisFunction over SPACE_DIM and remove this method?

Member AbstractTetrahedralMesh::load (Archive &archive, const unsigned int version)
#1199 make this work for everything else...

Member AbstractTetrahedralMesh::save (Archive &archive, const unsigned int version) const
#1200 This is bad for very large meshes. Consider making a symlink and just writing the permutation. Perhaps even copy the permutation file from an earlier checkpoint?

Member AbstractTetrahedralMeshWriter::WriteFilesUsingMesh (AbstractTetrahedralMesh< ELEMENT_DIM, SPACE_DIM > &rMesh)

#1322 Mesh should really be const!

#1322 Mesh should be const

#1322 This should be const too

Member AbstractTissue::AbstractTissue (std::vector< TissueCell > &rCells, const std::vector< unsigned > locationIndices=stdvector< unsigned >())
remove explicit use of NUM_CELL_PROLIFERATIVE_TYPES and NUM_CELL_CYCLE_PHASES as these may eventually differ between simulations (see #1285)

Member AbstractTissue::HasMesh ()

This method returns true if the tissue is a MeshBasedTissue or a VertexBasedTissue, but is actually used to tell force laws whether the tissue is a MeshBasedTissue. See #1303.

Member BackwardEulerNobleVargheseKohlNoble1998::GetIIonic ()

we need to + Check this scaling + Ask JonC to amend PyCml if necessary + Check other cell models

Member BidomainDg0Assembler::CheckCompatibilityCondition ()
#1327 This could be a collective MPI-like operation

Member BidomainProblem::AtBeginningOfTimestep (double time)
#1159 #1324 heart/src/problem/AbstractCardiacProblem.hpp:657 expects both pointing at the same place when unarchiving

Member BidomainProblem::LoadExtraArchiveForBidomain (Archive &archive, unsigned version)
#1159 sanity check that the contents of p_bcc and mpElectrodes->GetBoundaryConditionsContainer() match.

Member BidomainWithBathAssembler::FinaliseLinearSystem (Vec existingSolutionOrGuess, double time, bool assembleVector, bool assembleMatrix)

: #1215 #1328 this seems not to be an issue anymore. Document and remove code.

#1328 This code may no longer be needed since all the operations in the following loop may apply only to local elements. MatSetValue and VecSetValue are not collective...

Member BidomainWithBathMatrixBasedAssembler::BidomainWithBathMatrixBasedAssembler (AbstractTetrahedralMesh< ELEMENT_DIM, SPACE_DIM > *pMesh, BidomainPde< SPACE_DIM > *pPde, BoundaryConditionsContainer< ELEMENT_DIM, SPACE_DIM, 2 > *pBcc, unsigned numQuadPoints=2)
#1063 at this point we'll have a BidomainWithBathRhsMatrixAssembler object and a BidomainRhsMatrixAssembler object in memory. This is a waste of memory since both construct and store a matrix for RHS assembly.

Member BidomainWithBathMatrixBasedAssembler::mpBidomainWithBathRhsMatrixAssembler
#1063 Once BidomainWithBathRhsMatrixAssembler inherits from BidomainRhsMatrixAssembler we'll be able to reuse the pointer in BidomainMatrixBasedAssembler

Class BidomainWithBathRhsMatrixAssembler< DIM >
#1063 make this class inherit from BidomainRhsMatrixAssembler

Member BoundaryConditionsContainer::HasNeumannBoundaryCondition (const BoundaryElement< ELEMENT_DIM-1, SPACE_DIM > *pSurfaceElement, unsigned indexOfUnknown=0)

#1321 This is a horrendously inefficient fix. Perhaps have flag in element object?

Class BoundaryConditionsContainer< ELEMENT_DIM, SPACE_DIM, PROBLEM_DIM >
#1321 Various operations are currently very inefficient - there is certainly scope for optimisation here!

Member CardiacElectroMechanicsProblem::CardiacElectroMechanicsProblem (ContractionModel contractionModel, TetrahedralMesh< DIM, DIM > *pElectricsMesh, QuadraticMesh< DIM > *pMechanicsMesh, std::vector< unsigned > fixedMechanicsNodes, AbstractCardiacCellFactory< DIM > *pCellFactory, double endTime, double electricsPdeTimeStep, unsigned numElecTimeStepsPerMechTimestep, double contractionModelOdeTimeStep, std::string outputDirectory)
Cover these lines

Member CardiacElectroMechanicsProblem::WriteWatchedLocationData (double time, Vec voltage)
Improve efficiency of this method?

Member CardiacSimulationArchiver::Save (PROBLEM_CLASS &simulationToArchive, const std::string &rDirectory, bool clearDirectory=true)
#1026 get a real version number!

Member CellProperties::CalculateActionPotentialDurations (const double percentage)
#913 linear interpolation here too?

Member CML_noble_varghese_kohl_noble_1998_basic::GetIIonic ()

we need to + Check this scaling + Ask JonC to amend PyCml if necessary + Check other cell models

Member CML_noble_varghese_kohl_noble_1998_basic_pe_lut::GetIIonic ()

we need to + Check this scaling + Ask JonC to amend PyCml if necessary + Check other cell models

Member ColumnDataReader::mVariablesToColumns
Change int to unsigned? (#991)

Member DistributedTetrahedralMesh::ComputeMeshPartitioning (AbstractMeshReader< ELEMENT_DIM, SPACE_DIM > &rMeshReader, std::set< unsigned > &rNodesOwned, std::set< unsigned > &rHaloNodesOwned, std::set< unsigned > &rElementsOwned, std::vector< unsigned > &rProcessorsOffset)
#1293 add a timing event for the partitioning

Member DistributedTetrahedralMesh::ConstructFromMeshReader (AbstractMeshReader< ELEMENT_DIM, SPACE_DIM > &rMeshReader)
#1289 assert the node is not considered both owned and halo-owned.

Member Element::CalculatePsi (ChastePoint< SPACE_DIM > testPoint)
#1326 This method shouldn't need a new Jacobian inverse for every Psi

Class Exception
Might we want this class to inherit from STL exceptions?

Member ExponentialMaterialLaw::Get_d2W_dI1 (double I1, double I2)

The name of this method should not include underscores.

Member ExponentialMaterialLaw::Get_d2W_dI1I2 (double I1, double I2)

The name of this method should not include underscores.

Member ExponentialMaterialLaw::Get_d2W_dI2 (double I1, double I2)

The name of this method should not include underscores.

Member ExponentialMaterialLaw::Get_dW_dI1 (double I1, double I2)

The name of this method should not include underscores.

Member ExponentialMaterialLaw::Get_dW_dI2 (double I1, double I2)

The name of this method should not include underscores.

Member GeneralPlaneStimulusCellFactory::GeneralPlaneStimulusCellFactory (unsigned numEleAcross, double meshWidth, bool useMeshWidthAsMag=false, double stimulusMagnitude=-1e7, double stimulusDuration=0.5)

The useMeshWidth is temporary, while we are sorting out 3D stimulus. It is to be removed later (along with StimulusConvergenceTester) scale stimulus depending on space_step of elements

It looks like the value of the stimulus is specific to 3D

Class Hdf5DataReader
: magic number

Member Hdf5DataReader::Close ()
: move code to the destructor???

Member Hdf5DataReader::GetVariableOverNodes (Vec data, const std::string &rVariableName, unsigned timestep=0)
Use DistributedVector?

Member Hdf5DataReader::MAX_DATASET_RANK
: define it once

Member Hdf5DataWriter::DATASET_DIMS
: define it once

Member Hdf5DataWriter::Hdf5DataWriter (DistributedVectorFactory &rVectorFactory, const std::string &rDirectory, const std::string &rBaseName, bool cleanDirectory=true, bool extendData=false)
1300 We can't set mDataFixedDimensionSize, because the information isn't in the input file. This means that checking the size of input vectors in PutVector and PutStripedVector is impossible.

Member Hdf5DataWriter::PutStripedVector (int firstVariableID, int secondVariableID, Vec petscVector)
Use distributed vector functionality here?

Member HeartConfig::GetCellHeterogeneities (std::vector< AbstractChasteRegion< DIM > * > &rCellHeterogeneityRegions, std::vector< double > &rScaleFactorGks, std::vector< double > &rScaleFactorIto, std::vector< double > &rScaleFactorGkr)

- do we assume the vectors are initially empty? The returned std::vectors are all of the same length

There is no set method

Member HeartConfig::GetConductivityHeterogeneities (std::vector< ChasteCuboid< DIM > > &conductivitiesHeterogeneityAreas, std::vector< c_vector< double, 3 > > &intraConductivities, std::vector< c_vector< double, 3 > > &extraConductivities) const

- do we assume the vectors are initially empty? The returned std::vectors are all of the same length

When this is implemented, then we require an example in ChasteParametersFullFormat.xml

Member HeartConfig::GetIonicModelRegions (std::vector< ChasteCuboid< DIM > > &rDefinedRegions, std::vector< cp::ionic_model_selection_type > &rIonicModels) const
When this is implemented, then we require an example in ChasteParametersFullFormat.xml

Member HeartConfig::GetSlabDimensions (c_vector< double, 3 > &slabDimensions) const
IsMeshProvided and GetLoadMesh are subtly different but very similar. Can one of them go?

Member HeartConfig::GetStimuli (std::vector< boost::shared_ptr< SimpleStimulus > > &rStimuliApplied, std::vector< ChasteCuboid< DIM > > &rStimulatedAreas) const

- do we assume the vectors are initially empty? The returned std::vectors are all of the same length

There is no set method

Member HeartConfig::SetBathConductivity (double bathConductivity)
Is this used anywhere?

Member HeartConfig::SetIonicModelRegions (std::vector< ChasteCuboid< 3 > > &rDefinedRegions, std::vector< cp::ionic_model_selection_type > &rIonicModels) const
will this break if the user parameters don't include an IonicModels element?

Member HeartConfig::SetMaxUpstrokeVelocityMaps (std::vector< double > &maxUpstrokeVelocityMaps)
improve the description of threshold) with respect to which the upstroke velocity maps are calculated.

Member HeartConfig::SetMeshFileName (std::string meshPrefix, cp::media_type fibreDefinition=cpmedia_type::NoFibreOrientation)
There is no Get method

Member HeartConfig::SetUpstrokeTimeMaps (std::vector< double > &upstrokeTimeMaps)
improve the description of threshold) with respect to which the upstroke time maps are calculated.

Class LabelledCellMutationState
Fixing this is part of #1285.

Member LinearSystem::LinearSystem (PetscInt lhsVectorSize, MatType matType=(MatType) MATMPIAIJ)

: if we create a linear system object outside a cardiac assembler, these are gonna be the default solver and preconditioner. Not consitent with ChasteDefaults.xml though...

: if we create a linear system object outside a cardiac assembler, these are gonna be the default solver and preconditioner. Not consitent with ChasteDefaults.xml though...

: if we create a linear system object outside a cardiac assembler, these are gonna be the default solver and preconditioner. Not consitent with ChasteDefaults.xml though...

Member LinearSystem::mOwnershipRangeLo
Verify claim that ownership range for Vec and Mat is same. This should only matter for efficiency if the claim is false.

Member LinearSystem::SetMatrixIsSymmetric (bool isSymmetric=true)
: shall we allow modifying the symmetry flag anytime?

Member LinearSystem::Solve (Vec lhsGuess=NULL)

never tested in linalg component

Should it be compulsory for the caller to supply this and manage the memory?

Member LinearSystem::~LinearSystem ()
Never tested in linalg component

Member MeshBasedTissue::SetOutputTissueAreas (bool writeTissueAreas)

Extend this to 3D (possibly rename to SetOutputTissueVolumes?) - see also #738

Member MeshBasedTissue::WriteResultsToFiles ()

implement writing of tissue/cell lengths in 1D (see also #738)

implement writing of tissue/cell volumes in 3D (see also #738)

Member MooneyRivlinMaterialLaw::Get_d2W_dI1 (double I1, double I2)

The name of this method should not include underscores.

Member MooneyRivlinMaterialLaw::Get_d2W_dI1I2 (double I1, double I2)

The name of this method should not include underscores.

Member MooneyRivlinMaterialLaw::Get_d2W_dI2 (double I1, double I2)

The name of this method should not include underscores.

Member MooneyRivlinMaterialLaw::Get_dW_dI1 (double I1, double I2)

The name of this method should not include underscores.

Member MooneyRivlinMaterialLaw::Get_dW_dI2 (double I1, double I2)

The name of this method should not include underscores.

Member MutableMesh::CheckIsVoronoi (double maxPenetration=0.0)

use ElementIterator here?

Should use a set union operation here

Member MutableMesh::ReMesh (NodeMap &map)

communicate the length first

use EXPECT0 here

Member MutableMesh::RescaleMeshFromBoundaryNode (ChastePoint< 1 > updatedPoint, unsigned boundaryNodeIndex)
should unsigned GetNumBoundaryNodes() be overloaded too??

Class NonlinearElasticityAssembler< DIM >
: factor out Dof handling?

Member OdeSystemInformation::mpInstance
see if using weak_ptr would work and give funkier semantics (automatically destroy the singleton when no ODE systems were using it)

Member OutputFileHandler::MakeFoldersAndReturnFullPath (const std::string &rDirectory)
Put the Chaste signature file in all folders we have created

Class pack< void(T)>
Check if we need this on Boost>=1.38. Even if it's not needed there, we might still need it to load 1.33.1 archives.

Member ParallelColumnDataWriter::PutVectorStripe (int variableId, DistributedVector::Stripe &rStripe)
allow this to be a const-reference

Member PCBlockDiagonal::PCBlockDiagonalContext::A11_matrix_subblock
- don't create this every iteration but save it first time is needed.

Member PCBlockDiagonal::PCBlockDiagonalContext::A22_matrix_subblock
- don't create this every iteration but save it first time is needed.

Member PCBlockDiagonal::PCBlockDiagonalContext::PC_amg_A11
- don't create this every iteration but save it first time is needed.

Member PCBlockDiagonal::PCBlockDiagonalContext::PC_amg_A22
- don't create this every iteration but save it first time is needed.

Member PCLDUFactorisation::PCLDUFactorisationContext::A11_matrix_subblock
- don't create this every iteration but save it first time is needed.

Member PCLDUFactorisation::PCLDUFactorisationContext::A22_matrix_subblock
- don't create this every iteration but save it first time is needed.

Member PCLDUFactorisation::PCLDUFactorisationContext::B_matrix_subblock
- don't create this every iteration but save it first time is needed.

Member PCLDUFactorisation::PCLDUFactorisationContext::PC_amg_A11
- don't create this every iteration but save it first time is needed.

Member PCLDUFactorisation::PCLDUFactorisationContext::PC_amg_A22
- don't create this every iteration but save it first time is needed.

Member PolynomialMaterialLaw3d::Get_d2W_dI1 (double I1, double I2)

The name of this method should not include underscores.

Member PolynomialMaterialLaw3d::Get_d2W_dI1I2 (double I1, double I2)

The name of this method should not include underscores.

Member PolynomialMaterialLaw3d::Get_d2W_dI2 (double I1, double I2)

The name of this method should not include underscores.

Member PolynomialMaterialLaw3d::Get_dW_dI1 (double I1, double I2)

The name of this method should not include underscores.

Member PolynomialMaterialLaw3d::Get_dW_dI2 (double I1, double I2)

The name of this method should not include underscores.

Member PostProcessingWriter::WriteAboveThresholdDepolarisationFile (double threshold)

This method ought to be private and called by the WritePostProcessingFiles method if the user requests for it. This will be possible after modifying the schema and specifying Get and Set methods in HeartConfig to check whetehr the user wants this file or not

Member QuadraticMesh::HelperMethod1 (unsigned boundaryElemNode0, unsigned boundaryElemNode1, Element< DIM, DIM > *pElement, unsigned node0, unsigned node1, unsigned node2, unsigned &rOffset, bool &rReverse)

document these parameters

Member QuadraticMesh::HelperMethod2 (BoundaryElement< DIM-1, DIM > *pBoundaryElement, Element< DIM, DIM > *pElement, unsigned internalNode0, unsigned internalNode1, unsigned internalNode2, unsigned offset, bool reverse)

document these parameters

Member QuadraticMesh::RunMesherAndReadMesh (std::string binary, std::string outputDir, std::string fileStem)
: Could use the '-nn' flag when calling tetgen and then face file would have containing element info and second false

Member QuadraturePointsGroup::Get (unsigned i)

this method should be renamed rGet() as it returns a reference

this method should be renamed rGet() as it returns a reference

Member SimpleNonlinearEllipticAssembler::ComputeMatrixTerm (c_vector< double, ELEMENT_DIM+1 > &rPhi, c_matrix< double, SPACE_DIM, ELEMENT_DIM+1 > &rGradPhi, ChastePoint< SPACE_DIM > &rX, c_vector< double, 1 > &rU, c_matrix< double, 1, SPACE_DIM > &rGradU, Element< ELEMENT_DIM, SPACE_DIM > *pElement)
#1298 Should these be SPACE_DIM??

Class SimpleNonlinearEllipticAssembler< ELEMENT_DIM, SPACE_DIM >
[old todo, maybe not true anymore after refactor(?)] #1298 This class could do with some tidying. More (3D) tests are also needed. It probably needs re-writing to take advantage of parallel machines.

Member TetrahedralMesh::GetContainingElementIndex (ChastePoint< SPACE_DIM > testPoint, bool strict=false, std::set< unsigned > testElements=stdset< unsigned >(), bool onlyTryWithTestElements=false)

#1299 What if the element is deleted?

#1299 Polling every element is unnecessary. We ought to start from a likely place and hill climb

#1299 What if the element is deleted?

Member TetrahedralMesh::GetContainingElementIndexWithInitialGuess (ChastePoint< SPACE_DIM > testPoint, unsigned startingElementGuess, bool strict=false)
#1299 What if the element is deleted?

Member TetrahedralMesh::GetContainingElementIndices (ChastePoint< SPACE_DIM > testPoint)
#1299 What if the element is deleted?

Member TetrahedralMesh::GetNearestElementIndex (ChastePoint< SPACE_DIM > testPoint)

#1299 This ought to return a set of all elements that contain the point (if the point is a node in the mesh then it's contained in multiple elements)

#1299 Polling every element is unnecessary. We ought to start from a likely place and hill climb

#1299 What if the element is deleted?

Member TissueConfig::Reset ()

Fix this comment (see also #1294) mMembraneSurfaceEnergyParameter has ? units

Fix this comment (see also #1294) mCellCellAdhesionEnergyParameter has ? units

Fix this comment (see also #1294) mCellBoundaryAdhesionEnergyParameter has ? units

Fix this comment (see also #1294) mWelikyOsterAreaParameter has ? units

Fix this comment (see also #1294) mWelikyOsterPerimeterParameter has ? units

Fix this comment (see also #1294)

Member TissueSimulation::CalculateCellDivisionVector (TissueCell &rParentCell)
Could remove this dynamic_cast by moving the code block below into AbstractCellCentreBasedTissue::AddCell(), allowing it to be overruled by this method when overridden in subclasses. See also comment on #1093.

Member TrianglesMeshReader::OpenNodeFile ()
Change name to OpenNodesFile for consistency with OpenElementsFile and OpenFacesFile? (#991)

Member VertexElement::GetNodeLocalIndex (unsigned globalIndex)

This method could be moved to the AbstactElement class (#1304)

Class VertexElement< 1, SPACE_DIM >
Move implementation into .cpp file? (#1304)

Member VertexElement< 1, SPACE_DIM >::GetNodeLocalIndex (unsigned globalIndex)

This method could be moved to the AbstactElement class (#1304)

Member VertexMesh::GetAreaOfFace (VertexElement< ELEMENT_DIM-1, SPACE_DIM > *pFace)
reduce code duplication with GetAreaOfElement() method (see #1283 and #1276)

Member VertexMesh::GetCentroidOfElement (unsigned index)
Why isn't this just the centre of mass? (#1075)

Member VertexMesh::GetEdgeLength (unsigned elementIndex1, unsigned elementIndex2)
Move this bit of code into LinearSpringWithVariableSpringConstantsForce::VariableSpringConstantMultiplicationFactor() and make use of IsGhostNode() (#1075)

Member VertexMesh::GetNeighbouringNodeNotAlsoInElement (unsigned nodeIndex, unsigned elemIndex)
We should probably assert here that the node is in fact contained in the element (#1305)

Member VertexMesh::GetShortAxisOfElement (unsigned index)

This method is only called inside DivideElementAlongShortAxis() - get rid of it and move the code into that method? (#1276)

Member VertexMesh::SolveBoundaryElementMapping (unsigned index) const
sort out boundary elements in a vertex mesh (#943)

Class VertexMesh< ELEMENT_DIM, SPACE_DIM >::VertexElementIterator
This is the same as in AbstractTetrahedralMesh (#1276)

Member VertexMeshReader::GetNextFaceData ()
Implement this method (#1076)

Member VertexMeshReader::GetNumEdges () const
Implement this method (#1076)

Member VertexMeshReader::GetNumFaces () const
Implement this method (#1076)

Member VertexMeshWriter::WriteFiles ()
need to think about how best to do this in 3D (#866, #1076)

Member VertexMeshWriter::WriteFilesUsingMesh (VertexMesh< ELEMENT_DIM, SPACE_DIM > &rMesh)

Mesh should be const (#1076)

Mesh should be const (#1076)

Member VoronoiTessellation::GetNumFaces () const
If mLocationIndices is not empty, then should this return mLocationIndices.size()? See also #1257.

Generated by  doxygen 1.6.2