Memosa-FVM
0.2
|
#include <CRConnectivity.h>
Public Types | |
enum | CRTYPE { CELLCELL1 = 1, CELLCELL2 = 2 } |
typedef Array< Vector< int, 2 > > | PairToColMapping |
Public Member Functions | |
CRConnectivity (const StorageSite &rowSite, const StorageSite &colSite) | |
~CRConnectivity () | |
DEFINE_TYPENAME ("CRConnectivity") | |
int | getRowDim () const |
int | getColDim () const |
const StorageSite & | getRowSite () const |
const StorageSite & | getColSite () const |
shared_ptr< CRConnectivity > | getTranspose () const |
shared_ptr< CRConnectivity > | getMultiTranspose (const int varSize) const |
shared_ptr< CRConnectivity > | multiply (const CRConnectivity &b, const bool implicitDiagonal) const |
shared_ptr< CRConnectivity > | createOffset (const StorageSite &newRowSite, const int offset, const int size) const |
shared_ptr< CRConnectivity > | getSubset (const StorageSite &site, const Array< int > &indices) const |
void | reorder (const Array< int > &indices) |
shared_ptr< CRConnectivity > | getLocalizedSubset (const StorageSite &newRowSite, StorageSite &newColSite, const Array< int > &indices) const |
shared_ptr< CRConnectivity > | getLocalizedSubsetOfFaceCells (const StorageSite &newRowSite, StorageSite &newColSite, const Array< int > &indices, const CRConnectivity &faceCells, const CRConnectivity &cellCells) const |
shared_ptr< CRConnectivity > | getLocalizedSubsetOfFaceCells (const StorageSite &newRowSite, StorageSite &newColSite, const Array< int > &indices, const CRConnectivity &cellParts, const int partID) const |
void | localize (const Array< int > &globalToLocal, const StorageSite &newColSite) |
int | operator() (const int i, const int j) const |
int & | operator() (const int i, const int j) |
int | getCoeffPosition (const int i, const int j) const |
int | getCount (const int i) const |
const Array< int > & | getGlobalToLocalMap () const |
const Array< int > & | getLocalToGlobalMap () const |
const map< int, int > & | getGlobalToLocalMapper () const |
map< int, int > & | getGlobalToLocalMapper () |
shared_ptr< Array< int > > | getGlobalToLocalMapPtr () |
shared_ptr< Array< int > > | getLocalToGlobalMapPtr () |
const PairToColMapping & | getPairToColMapping (const CRConnectivity &pairs) const |
void | clearPairToColMapping (const CRConnectivity &pairs) const |
void | setConnType (CRTYPE type) |
const CRTYPE & | getConnType () const |
void | initCount () |
void | addCount (const int index, const int count) |
void | finishCount () |
int | add (const int index, const int val) |
void | finishAdd () |
void | resizeLocalToGlobalMap (int size) |
const Array< int > & | getRow () const |
const Array< int > & | getCol () const |
Array< int > & | getCol () |
Private Member Functions | |
CRConnectivity (const CRConnectivity &) | |
Private Attributes | |
StorageSite const * | _rowSite |
StorageSite const * | _colSite |
int | _rowDim |
int | _colDim |
shared_ptr< Array< int > > | _row |
shared_ptr< Array< int > > | _col |
shared_ptr< Array< int > > | _globalToLocalMap |
map< int, int > | _globalToLocalMapper |
shared_ptr< Array< int > > | _localToGlobalMap |
map< const CRConnectivity *, PairToColMapping * > | _pairToColMappings |
CRTYPE | _connType |
Stores connectivity information using a compressed row format. Basically this means that we have a (integer) row array that stores the indices into col array (also integer) where the non zero entries for a particular row begin. Thus col[row[i]] through col[row[i+1]] store the column indices j where a sparse matrix based on this connectivity would have non zero entries.
Objects of this class can be used to store connectivities between mesh elements such as the faces of a cell or the cells surrounding a node etc. It can also be used to represent the fill pattern of an arbitrary sparse matrix (see CRMatrix).
This class provides support for constructing the connectivity in a two step fashion but is not usable for dynamically changing the connectivity. Typical usage is
– construct by specifying rowSite and colSite. Thus the dimensions are known but not the number of nonzero entries
– call initCount to start the process of counting non zeros
– call addCount to specify the number of non zeros for each row i (this can be in any order and multiple calls for same row are allowed)
– call finishCount - this allocates the col array and resets row array so that it is ready for entries to be added
– call add to specify the nonzero location j for each row i (this can also be in any order but each i,j must be specified only once)
Since we treat this connectivity as a matrix we can perform operations like transpose (to get node - cell connectvity from cell
Definition at line 52 of file CRConnectivity.h.
typedef Array<Vector<int,2> > CRConnectivity::PairToColMapping |
Definition at line 55 of file CRConnectivity.h.
Enumerator | |
---|---|
CELLCELL1 | |
CELLCELL2 |
Definition at line 57 of file CRConnectivity.h.
CRConnectivity::CRConnectivity | ( | const StorageSite & | rowSite, |
const StorageSite & | colSite | ||
) |
Definition at line 11 of file CRConnectivity.cpp.
References _colDim, _rowDim, and logCtorVerbose.
Referenced by createOffset(), getLocalizedSubset(), getLocalizedSubsetOfFaceCells(), getMultiTranspose(), getSubset(), getTranspose(), and multiply().
CRConnectivity::~CRConnectivity | ( | ) |
Definition at line 29 of file CRConnectivity.cpp.
References _colDim, _pairToColMappings, _rowDim, and logDtorVerbose.
|
private |
|
inline |
Definition at line 123 of file CRConnectivity.h.
Referenced by Mesh::addCRConn(), KSConnectivity< T >::addOther(), KSConnectivity< T >::addSelf(), CRMatrix< T_Diag, T_OffDiag, X >::compute_ILU0(), getLocalizedSubset(), getLocalizedSubsetOfFaceCells(), getMultiTranspose(), getSubset(), getTranspose(), multiply(), and FluentReader::readFaces().
|
inline |
Definition at line 116 of file CRConnectivity.h.
Referenced by KSConnectivity< T >::addCountOther(), KSConnectivity< T >::addCountSelf(), CRMatrix< T_Diag, T_OffDiag, X >::compute_ILU0(), Mesh::countCRConn(), getLocalizedSubset(), getLocalizedSubsetOfFaceCells(), getMultiTranspose(), getSubset(), getTranspose(), multiply(), and FluentReader::readFaces().
void CRConnectivity::clearPairToColMapping | ( | const CRConnectivity & | pairs | ) | const |
Definition at line 807 of file CRConnectivity.cpp.
References _pairToColMappings.
shared_ptr< CRConnectivity > CRConnectivity::createOffset | ( | const StorageSite & | newRowSite, |
const int | offset, | ||
const int | size | ||
) | const |
Definition at line 796 of file CRConnectivity.cpp.
References _col, _colSite, _row, and CRConnectivity().
Referenced by Mesh::getFaceCells(), and Mesh::getFaceNodes().
CRConnectivity::DEFINE_TYPENAME | ( | "CRConnectivity" | ) |
void CRConnectivity::finishAdd | ( | ) |
Definition at line 64 of file CRConnectivity.cpp.
Referenced by Mesh::addCRConn(), CRMatrix< T_Diag, T_OffDiag, X >::compute_ILU0(), KSConnectivity< T >::finishAddOther(), KSConnectivity< T >::finishAddSelf(), getLocalizedSubset(), getLocalizedSubsetOfFaceCells(), getMultiTranspose(), getSubset(), getTranspose(), and multiply().
void CRConnectivity::finishCount | ( | ) |
Definition at line 47 of file CRConnectivity.cpp.
References _col, _row, and _rowDim.
Referenced by CRMatrix< T_Diag, T_OffDiag, X >::compute_ILU0(), Mesh::countCRConn(), KSConnectivity< T >::finishCountOther(), KSConnectivity< T >::finishCountSelf(), getLocalizedSubset(), getLocalizedSubsetOfFaceCells(), getMultiTranspose(), getSubset(), getTranspose(), and multiply().
|
inline |
Definition at line 150 of file CRConnectivity.h.
Referenced by setFlatCoeffs().
|
inline |
Definition at line 183 of file CRConnectivity.h.
References _col.
Referenced by CRMatrix< T_Diag, T_OffDiag, X >::compute_ILU0(), KineticModel< T >::computeIBFaceDsf(), COMETModel< T >::computeIBFaceDsf(), MeshMetricsCalculator< T >::computeIBInterpolationMatrices(), MeshMetricsCalculator< T >::computeIBInterpolationMatricesCells(), KineticModel< T >::computeSolidFaceDsf(), COMETModel< T >::computeSolidFaceDsf(), MeshMetricsCalculator< T >::computeSolidInterpolationMatrices(), ElectricModel< T >::Impl::computeSolidSurfaceForce(), FlowModel< T >::Impl::computeSolidSurfaceForce(), KineticModel< T >::computeSurfaceForce(), COMETModel< T >::computeSurfaceForce(), NcDataWriter::connectivities(), MeshPartitioner::CRConnectivityPrint(), Mesh::CRConnectivityPrint(), IBManager::CRConnectivityPrintFile(), MeshPartitioner::CRConnectivityPrintFile(), Mesh::CRConnectivityPrintFile(), Mesh::createAndGetBNglobalToLocal(), CRMatrixRect< T_Coeff, X, B >::createCoarseMatrix(), CRMatrix< T_Diag, T_OffDiag, X >::createCoarseMatrix(), FluentReader::createMesh(), debug_mesh(), IbmDiscretization< X, Diag, OffDiag >::discretize(), StructureSourceDiscretization< T, Diag, OffDiag >::discretizeFaces(), StructurePlasticDiscretization< T, Diag, OffDiag >::discretizeFaces(), PlateSourceDiscretization< T, Diag, OffDiag >::discretizeFaces(), FlowModel< T >::Impl::dumpContinuityMatrix(), ThermalModel< T >::Impl::dumpMatrix(), VacancyModel< T >::Impl::dumpMatrix(), PlateModel< T >::Impl::dumpMatrix(), KSConnectivity< T >::expandMySelfOther(), KSConnectivity< T >::expandMySelfSelf(), Mesh::getCellCells2(), KSConnectivity< T >::getOtherCol(), getPairToColMapping(), KSConnectivity< T >::getSelfCol(), KSConnectivity< T >::multiplyOther(), KSConnectivity< T >::multiplySelf(), setFlatCoeffs(), SpikeMatrix< T_Diag, T_OffDiag, X >::setMatrix(), SpikeStorage::setOffDiagPtr(), and Mesh::uniqueFaceCells().
|
inline |
|
inline |
|
inline |
Definition at line 72 of file CRConnectivity.h.
References _colSite.
Referenced by CRMatrix< T_Diag, T_OffDiag, X >::compute_ILU0().
|
inline |
Definition at line 208 of file CRConnectivity.h.
References _connType.
Referenced by CRMatrix< T_Diag, T_OffDiag, X >::eliminateBoundaryEquations().
|
inline |
returns the number of non zeroes for row i
Definition at line 165 of file CRConnectivity.h.
References _row.
Referenced by AABB::AABB(), Mesh::addCRConn(), addFluidNeighbors(), MovingMeshModel< T >::advance(), COMETBoundaryConditions< X, Diag, OffDiag >::applyPressureInletBC(), COMETBoundaryConditions< X, Diag, OffDiag >::applyRealWallBC(), COMETBoundary< T >::applyTemperatureWallFine(), COMETBoundaryConditions< X, Diag, OffDiag >::applyZeroGradientBC(), MeshMetricsCalculator< T >::calculateBoundaryNodeNormal(), MeshMetricsCalculator< T >::calculateCellCentroids(), MeshMetricsCalculator< T >::calculateFaceAreas(), MeshMetricsCalculator< T >::calculateFaceCentroids(), StructureDeformationModel< T >::calculateNodeDisplacement(), PlateDeformationModel< T >::calculateNodeDisplacement(), MeshPartitioner::cellcells_global_extension(), CellMark_Impl(), COMETModel< T >::coarsenInterfaceCells(), COMETModel< T >::coarsenInterior(), COMETESBGKDiscretizer< T >::COMETConvection(), COMETDiscretizer< T >::COMETConvection(), COMETDiscretizer< T >::COMETConvectionCoarse(), COMETESBGKDiscretizer< T >::COMETConvectionFine(), COMETDiscretizer< T >::COMETConvectionFine(), COMETDiscretizer< T >::correctInterface(), COMETModel< T >::correctSolution(), Mesh::countCRConn(), MeshAssembler::countInterfaceNodes(), CRMatrixRect< T_Coeff, X, B >::createCoarseConnectivity(), CRMatrix< T_Diag, T_OffDiag, X >::createCoarseConnectivity(), DiagonalMatrix< Diag, X >::createCoarseMatrix(), CRMatrixRect< T_Coeff, X, B >::createCoarseMatrix(), CRMatrix< T_Diag, T_OffDiag, X >::createCoarseMatrix(), IBManager::createIBInterpolationStencil(), Mesh::createScatterGatherCountsBuffer(), CRMatrix< T_Diag, T_OffDiag, X >::createScatterGatherCountsBuffer(), Mesh::createScatterGatherIndicesBuffer(), CRMatrix< T_Diag, T_OffDiag, X >::createScatterGatherIndicesBuffer(), GradientMatrix< T_Scalar >::createScatterGatherValuesBuffer(), CRMatrix< T_Diag, T_OffDiag, X >::createScatterGatherValuesCRMtrxBuffer(), IBManager::createSolidInterpolationStencil(), MeshDismantler::debug_face_cells(), MeshDismantler::debug_face_nodes(), TrapBandTunnelingDiscretization< X, Diag, OffDiag >::discretize(), LinearizeDielectric< X, Diag, OffDiag >::discretize(), InjectionDiscretization< X, Diag, OffDiag >::discretize(), TunnelingDiscretization< X, Diag, OffDiag >::discretize(), PartMesh::dumpTecplot(), MeshPartitioner::extractBoundaryMesh(), Mesh::extractBoundaryMesh(), Mesh::extrude(), MeshDismantler::faceNodesAddBoundaryInterfaces(), MeshDismantler::faceNodesAddInteriorFaces(), MeshDismantler::faceNodesAddMeshInterfaces(), MeshDismantler::faceNodesAddPartitionInterfaces(), MeshDismantler::faceNodesInit(), Mesh::findCommonNodes(), Grid::findNeighborsByCells(), MeshPartitioner::get_local_nodes(), Mesh::getCellCells2(), MeshAssembler::getInnerNodesCount(), getLocalizedSubset(), getLocalizedSubsetOfFaceCells(), KSConnectivity< T >::getOtherCount(), getPairToColMapping(), KSConnectivity< T >::getSelfCount(), getSubset(), MeshPartitioner::globalCellID_procID_map(), inCell(), COMETModel< T >::injectResid(), MeshPartitioner::level1_scatter_gather_cells(), PartMesh::local_nodes(), COMETModel< T >::makeCellColors(), COMETModel< T >::MakeCoarseMesh1(), COMETModel< T >::MakeInteriorCoarseMesh(), markCell(), IBManager::markFluid(), IBManager::markIntersections(), PartMesh::mesh_tecplot(), MeshPartitioner::mesh_tecplot(), PartMesh::mesh_xdmfplot(), MeshPartitioner::mesh_xdmfplot(), AABB::meshIntersections(), Cell< CellTrait >::orderCellFacesAndNodes(), orderCellFacesAndNodes(), COMETDiscretizer< T >::ScatterPhonons(), MeshPartitioner::set_cellcells_global(), PartMesh::set_eptr_eind(), MeshPartitioner::set_eptr_eind(), MeshDismantler::set_local_global(), MeshPartitioner::set_local_global(), COMETESBGKDiscretizer< T >::setBoundaryValFine(), Mesh::setCommonFacesMap(), MeshAssembler::setFaceNodes(), setibFaceCells(), setibFaceParticles(), MeshAssembler::setInterfaceNodes(), MeshAssembler::setNodesMapper(), MeshDismantler::setNodesMapper(), MeshDismantler::setNodesSite(), FVMParticles::setParticles(), StructureDeformationModel< T >::updateBoundaryMesh(), PlateDeformationModel< T >::updateBoundaryMesh(), COMETDiscretizer< T >::updateGhostCoarse(), COMETDiscretizer< T >::updateGhostFine(), MovingMeshModel< T >::volChange(), and VTKWriter< T >::VTKWriter().
|
inline |
Definition at line 189 of file CRConnectivity.h.
References _globalToLocalMap.
Referenced by getLocalizedSubsetOfFaceCells(), and MeshPartitioner::preserve_cell_order().
|
inline |
Definition at line 192 of file CRConnectivity.h.
References _globalToLocalMapper.
|
inline |
Definition at line 193 of file CRConnectivity.h.
References _globalToLocalMapper.
|
inline |
Definition at line 195 of file CRConnectivity.h.
References _globalToLocalMap.
shared_ptr< CRConnectivity > CRConnectivity::getLocalizedSubset | ( | const StorageSite & | newRowSite, |
StorageSite & | newColSite, | ||
const Array< int > & | indices | ||
) | const |
Definition at line 621 of file CRConnectivity.cpp.
References _col, _colDim, _globalToLocalMap, _localToGlobalMap, _row, add(), addCount(), CRConnectivity(), finishAdd(), finishCount(), getCount(), Array< T >::getLength(), initCount(), and StorageSite::setCount().
Referenced by debug_mesh().
shared_ptr< CRConnectivity > CRConnectivity::getLocalizedSubsetOfFaceCells | ( | const StorageSite & | newRowSite, |
StorageSite & | newColSite, | ||
const Array< int > & | indices, | ||
const CRConnectivity & | faceCells, | ||
const CRConnectivity & | cellCells | ||
) | const |
Definition at line 311 of file CRConnectivity.cpp.
References _col, _colDim, _globalToLocalMap, _localToGlobalMap, _row, add(), addCount(), CRConnectivity(), finishAdd(), finishCount(), getCount(), getGlobalToLocalMap(), Array< T >::getLength(), getRowDim(), initCount(), max(), and StorageSite::setCount().
shared_ptr< CRConnectivity > CRConnectivity::getLocalizedSubsetOfFaceCells | ( | const StorageSite & | newRowSite, |
StorageSite & | newColSite, | ||
const Array< int > & | indices, | ||
const CRConnectivity & | cellParts, | ||
const int | partID | ||
) | const |
Definition at line 457 of file CRConnectivity.cpp.
References _col, _globalToLocalMap, _localToGlobalMap, _row, add(), addCount(), CRConnectivity(), finishAdd(), finishCount(), StorageSite::getCount(), getCount(), Array< T >::getLength(), getRowSite(), StorageSite::getSelfCount(), initCount(), and StorageSite::setCount().
|
inline |
Definition at line 190 of file CRConnectivity.h.
References _localToGlobalMap.
Referenced by CRMatrix< T_Diag, T_OffDiag, X >::createScatterGatherIndicesBuffer(), and MeshPartitioner::preserve_cell_order().
|
inline |
Definition at line 196 of file CRConnectivity.h.
References _localToGlobalMap.
shared_ptr< CRConnectivity > CRConnectivity::getMultiTranspose | ( | const int | varSize | ) | const |
Definition at line 101 of file CRConnectivity.cpp.
References _col, _colDim, _colSite, _row, _rowDim, _rowSite, add(), addCount(), CRConnectivity(), finishAdd(), finishCount(), and initCount().
Referenced by DirectSolver::solve().
const Array< Vector< int, 2 > > & CRConnectivity::getPairToColMapping | ( | const CRConnectivity & | pairs | ) | const |
Definition at line 730 of file CRConnectivity.cpp.
References _pairToColMappings, getCol(), getCount(), getRow(), and getRowDim().
Referenced by CRMatrixRect< T_Coeff, X, B >::getPairWiseAssembler(), and CRMatrix< T_Diag, T_OffDiag, X >::getPairWiseAssembler().
|
inline |
Definition at line 182 of file CRConnectivity.h.
References _row.
Referenced by CRMatrix< T_Diag, T_OffDiag, X >::compute_ILU0(), KineticModel< T >::computeIBFaceDsf(), COMETModel< T >::computeIBFaceDsf(), MeshMetricsCalculator< T >::computeIBInterpolationMatrices(), MeshMetricsCalculator< T >::computeIBInterpolationMatricesCells(), KineticModel< T >::computeSolidFaceDsf(), COMETModel< T >::computeSolidFaceDsf(), MeshMetricsCalculator< T >::computeSolidInterpolationMatrices(), ElectricModel< T >::Impl::computeSolidSurfaceForce(), FlowModel< T >::Impl::computeSolidSurfaceForce(), KineticModel< T >::computeSurfaceForce(), COMETModel< T >::computeSurfaceForce(), NcDataWriter::connectivities(), MeshPartitioner::CRConnectivityPrint(), Mesh::CRConnectivityPrint(), IBManager::CRConnectivityPrintFile(), MeshPartitioner::CRConnectivityPrintFile(), Mesh::CRConnectivityPrintFile(), Mesh::createAndGetBNglobalToLocal(), CRMatrixRect< T_Coeff, X, B >::createCoarseMatrix(), CRMatrix< T_Diag, T_OffDiag, X >::createCoarseMatrix(), FluentReader::createMesh(), debug_mesh(), IbmDiscretization< X, Diag, OffDiag >::discretize(), MomentumPressureGradientDiscretization< X >::discretize(), StructureSourceDiscretization< T, Diag, OffDiag >::discretizeFaces(), StructurePlasticDiscretization< T, Diag, OffDiag >::discretizeFaces(), PlateSourceDiscretization< T, Diag, OffDiag >::discretizeFaces(), FlowModel< T >::Impl::dumpContinuityMatrix(), VacancyModel< T >::Impl::dumpMatrix(), ThermalModel< T >::Impl::dumpMatrix(), PlateModel< T >::Impl::dumpMatrix(), KSConnectivity< T >::expandMySelfOther(), KSConnectivity< T >::expandMySelfSelf(), Mesh::getCellCells2(), GradientModel< Vector< T, 3 > >::getLeastSquaresGradientMatrix2D(), GradientModel< Vector< T, 3 > >::getLeastSquaresGradientMatrix3D(), KSConnectivity< T >::getOtherRow(), getPairToColMapping(), KSConnectivity< T >::getSelfRow(), KSConnectivity< T >::multiplyOther(), KSConnectivity< T >::multiplySelf(), FlowModel< T >::Impl::setDirichlet(), MeshAssembler::setFaceNodes(), setFlatCoeffs(), SpikeMatrix< T_Diag, T_OffDiag, X >::setMatrix(), SpikeStorage::setOffDiagPtr(), and Mesh::uniqueFaceCells().
|
inline |
Definition at line 68 of file CRConnectivity.h.
References _rowDim.
Referenced by Mesh::createAndGetBNglobalToLocal(), DiagonalMatrix< Diag, X >::createCoarseMatrix(), CRMatrixRect< T_Coeff, X, B >::createCoarseMatrix(), CRMatrix< T_Diag, T_OffDiag, X >::createCoarseMatrix(), debug_mesh(), getLocalizedSubsetOfFaceCells(), getPairToColMapping(), PartMesh::mesh_tecplot(), MeshPartitioner::mesh_tecplot(), FluxJacobianMatrix< OffDiag, X >::multiply(), FluxJacobianMatrix< OffDiag, X >::multiplyAndAdd(), and setFlatCoeffs().
|
inline |
Definition at line 71 of file CRConnectivity.h.
References _rowSite.
Referenced by CRMatrix< T_Diag, T_OffDiag, X >::compute_ILU0(), CRMatrix< T_Diag, T_OffDiag, X >::computeResidual(), CRMatrix< T_Diag, T_OffDiag, X >::createCoarsening(), CRMatrix< T_Diag, T_OffDiag, X >::createScatterGatherCountsBuffer(), CRMatrix< T_Diag, T_OffDiag, X >::createScatterGatherIndicesBuffer(), CRMatrix< T_Diag, T_OffDiag, X >::createScatterGatherValuesBBuffer(), CRMatrix< T_Diag, T_OffDiag, X >::createScatterGatherValuesCRMtrxBuffer(), CRMatrix< T_Diag, T_OffDiag, X >::eliminateBoundaryEquations(), CRMatrix< T_Diag, T_OffDiag, X >::eliminateRow(), CRMatrix< T_Diag, T_OffDiag, X >::eliminateRowGhost(), CRMatrix< T_Diag, T_OffDiag, X >::forwardGS(), SpikeStorage::gatherCellSizes(), CRMatrix< T_Diag, T_OffDiag, X >::get_request_size(), Mesh::getCellCells2(), GradientMatrix< T_Scalar >::getGradient(), getLocalizedSubsetOfFaceCells(), SpikeStorage::init(), CRMatrix< T_Diag, T_OffDiag, X >::Jacobi(), CRMatrix< T_Diag, T_OffDiag, X >::lowerSolve(), CRMatrixRect< T_Coeff, X, B >::multiply(), CRMatrix< T_Diag, T_OffDiag, X >::multiply(), CRMatrixTranspose< T_Coeff, X, B >::multiplyAndAdd(), CRMatrixRect< T_Coeff, X, B >::multiplyAndAdd(), CRMatrix< T_Diag, T_OffDiag, X >::multiplyAndAdd(), orderCellFacesAndNodes(), CRMatrix< T_Diag, T_OffDiag, X >::quadProduct(), CRMatrix< T_Diag, T_OffDiag, X >::reverseGS(), SpikeStorage::setGlobalIndices(), CRMatrix< T_Diag, T_OffDiag, X >::solveBoundary(), SpikeStorage::syncCellIDs(), CRMatrix< T_Diag, T_OffDiag, X >::syncCounts(), CRMatrix< T_Diag, T_OffDiag, X >::syncIndices(), CRMatrix< T_Diag, T_OffDiag, X >::syncValuesB(), CRMatrix< T_Diag, T_OffDiag, X >::syncValuesCRMtrx(), CRMatrix< T_Diag, T_OffDiag, X >::transpose(), Mesh::uniqueFaceCells(), and CRMatrix< T_Diag, T_OffDiag, X >::upperSolve().
shared_ptr< CRConnectivity > CRConnectivity::getSubset | ( | const StorageSite & | site, |
const Array< int > & | indices | ||
) | const |
Definition at line 274 of file CRConnectivity.cpp.
References _col, _colSite, _row, add(), addCount(), CRConnectivity(), finishAdd(), finishCount(), getCount(), Array< T >::getLength(), and initCount().
Referenced by debug_mesh().
shared_ptr< CRConnectivity > CRConnectivity::getTranspose | ( | ) | const |
Definition at line 74 of file CRConnectivity.cpp.
References _col, _colSite, _row, _rowDim, _rowSite, add(), addCount(), CRConnectivity(), finishAdd(), finishCount(), and initCount().
Referenced by StructureDeformationModel< T >::calculateNodeDisplacement(), PlateDeformationModel< T >::calculateNodeDisplacement(), COMETModel< T >::coarsenInterfaceCells(), Mesh::getCellFaces(), FluentReader::getNodeCells(), MeshDismantler::init(), COMETModel< T >::makeFinestToCoarseConn(), COMETModel< T >::MakeInteriorCoarseMesh(), and Mesh::setCommonFacesMap().
void CRConnectivity::initCount | ( | ) |
see comments above
Definition at line 41 of file CRConnectivity.cpp.
Referenced by CRMatrix< T_Diag, T_OffDiag, X >::compute_ILU0(), Mesh::countCRConn(), getLocalizedSubset(), getLocalizedSubsetOfFaceCells(), getMultiTranspose(), getSubset(), getTranspose(), KSConnectivity< T >::initOtherCount(), KSConnectivity< T >::initSelfCount(), and multiply().
void CRConnectivity::localize | ( | const Array< int > & | globalToLocal, |
const StorageSite & | newColSite | ||
) |
Definition at line 697 of file CRConnectivity.cpp.
References _col, _colDim, _colSite, StorageSite::getCount(), and Array< T >::getLength().
shared_ptr< CRConnectivity > CRConnectivity::multiply | ( | const CRConnectivity & | b, |
const bool | implicitDiagonal | ||
) | const |
Definition at line 168 of file CRConnectivity.cpp.
References _col, _colDim, _colSite, _row, _rowDim, _rowSite, add(), addCount(), CRConnectivity(), finishAdd(), finishCount(), and initCount().
Referenced by COMETModel< T >::coarsenInterfaceCells(), Mesh::getCellCells(), Mesh::getCellCells2(), FluentReader::getCellNodes(), Mesh::getFaceCells2(), and COMETModel< T >::MakeInteriorCoarseMesh().
|
inline |
|
inline |
returns the index of the j'th non zero column for row i
Definition at line 145 of file CRConnectivity.h.
References _col.
void CRConnectivity::reorder | ( | const Array< int > & | indices | ) |
Definition at line 687 of file CRConnectivity.cpp.
References _col, and Array< T >::getLength().
Referenced by MeshPartitioner::fiedler_partition().
|
inline |
direct access to row and col array
Definition at line 177 of file CRConnectivity.h.
References _localToGlobalMap.
|
inline |
|
private |
Definition at line 220 of file CRConnectivity.h.
Referenced by createOffset(), finishCount(), getCoeffPosition(), getCol(), getLocalizedSubset(), getLocalizedSubsetOfFaceCells(), getMultiTranspose(), getSubset(), getTranspose(), localize(), multiply(), operator()(), and reorder().
|
mutableprivate |
Definition at line 218 of file CRConnectivity.h.
Referenced by CRConnectivity(), getColDim(), getLocalizedSubset(), getLocalizedSubsetOfFaceCells(), getMultiTranspose(), localize(), multiply(), and ~CRConnectivity().
|
mutableprivate |
Definition at line 216 of file CRConnectivity.h.
Referenced by createOffset(), getColSite(), getMultiTranspose(), getSubset(), getTranspose(), localize(), and multiply().
|
private |
Definition at line 225 of file CRConnectivity.h.
Referenced by getConnType(), and setConnType().
|
private |
Definition at line 221 of file CRConnectivity.h.
Referenced by getGlobalToLocalMap(), getGlobalToLocalMapPtr(), getLocalizedSubset(), and getLocalizedSubsetOfFaceCells().
|
private |
Definition at line 222 of file CRConnectivity.h.
Referenced by getGlobalToLocalMapper().
|
private |
Definition at line 223 of file CRConnectivity.h.
Referenced by getLocalizedSubset(), getLocalizedSubsetOfFaceCells(), getLocalToGlobalMap(), getLocalToGlobalMapPtr(), and resizeLocalToGlobalMap().
|
mutableprivate |
Definition at line 224 of file CRConnectivity.h.
Referenced by clearPairToColMapping(), getPairToColMapping(), and ~CRConnectivity().
|
private |
Definition at line 219 of file CRConnectivity.h.
Referenced by createOffset(), finishAdd(), finishCount(), getCoeffPosition(), getCount(), getLocalizedSubset(), getLocalizedSubsetOfFaceCells(), getMultiTranspose(), getRow(), getSubset(), getTranspose(), initCount(), and multiply().
|
mutableprivate |
Definition at line 217 of file CRConnectivity.h.
Referenced by CRConnectivity(), finishAdd(), finishCount(), getMultiTranspose(), getRowDim(), getTranspose(), initCount(), multiply(), and ~CRConnectivity().
|
mutableprivate |
Definition at line 215 of file CRConnectivity.h.
Referenced by getMultiTranspose(), getRowSite(), getTranspose(), and multiply().