Public Member Functions | Protected Member Functions | Private Attributes | List of all members
oomph::DistributableLinearAlgebraObject Class Reference

Base class for any linear algebra object that is distributable. Just contains storage for the LinearAlgebraDistribution object and access functions. More...

#include <linear_algebra_distribution.h>

+ Inheritance diagram for oomph::DistributableLinearAlgebraObject:

Public Member Functions

 DistributableLinearAlgebraObject ()
 Default constructor - create a distribution. More...
 
 DistributableLinearAlgebraObject (const DistributableLinearAlgebraObject &matrix)
 Broken copy constructor. More...
 
void operator= (const DistributableLinearAlgebraObject &)
 Broken assignment operator. More...
 
virtual ~DistributableLinearAlgebraObject ()
 Destructor. More...
 
LinearAlgebraDistributiondistribution_pt () const
 access to the LinearAlgebraDistribution More...
 
unsigned nrow () const
 access function to the number of global rows. More...
 
unsigned nrow_local () const
 access function for the num of local rows on this processor. More...
 
unsigned nrow_local (const unsigned &p) const
 access function for the num of local rows on this processor. More...
 
unsigned first_row () const
 access function for the first row on this processor More...
 
unsigned first_row (const unsigned &p) const
 access function for the first row on this processor More...
 
bool distributed () const
 distribution is serial or distributed More...
 
bool distribution_built () const
 
void build_distribution (const LinearAlgebraDistribution *const dist_pt)
 setup the distribution of this distributable linear algebra object More...
 
void build_distribution (const LinearAlgebraDistribution &dist)
 setup the distribution of this distributable linear algebra object More...
 

Protected Member Functions

void clear_distribution ()
 clear the distribution of this distributable linear algebra object More...
 

Private Attributes

LinearAlgebraDistributionDistribution_pt
 the LinearAlgebraDistribution object More...
 

Detailed Description

Base class for any linear algebra object that is distributable. Just contains storage for the LinearAlgebraDistribution object and access functions.

Definition at line 443 of file linear_algebra_distribution.h.

Constructor & Destructor Documentation

◆ DistributableLinearAlgebraObject() [1/2]

oomph::DistributableLinearAlgebraObject::DistributableLinearAlgebraObject ( )
inline

Default constructor - create a distribution.

Definition at line 449 of file linear_algebra_distribution.h.

References oomph::LinearAlgebraDistribution::LinearAlgebraDistribution().

◆ DistributableLinearAlgebraObject() [2/2]

oomph::DistributableLinearAlgebraObject::DistributableLinearAlgebraObject ( const DistributableLinearAlgebraObject matrix)
inline

Broken copy constructor.

Definition at line 456 of file linear_algebra_distribution.h.

References oomph::BrokenCopy::broken_copy().

◆ ~DistributableLinearAlgebraObject()

virtual oomph::DistributableLinearAlgebraObject::~DistributableLinearAlgebraObject ( )
inlinevirtual

Destructor.

Definition at line 468 of file linear_algebra_distribution.h.

Member Function Documentation

◆ build_distribution() [1/2]

void oomph::DistributableLinearAlgebraObject::build_distribution ( const LinearAlgebraDistribution *const  dist_pt)
inline

setup the distribution of this distributable linear algebra object

Definition at line 524 of file linear_algebra_distribution.h.

Referenced by oomph::DoubleVector::build(), oomph::DoubleMultiVector::build(), oomph::MumpsSolver::factorise(), oomph::SuperLUSolver::factorise_distributed(), oomph::DoubleVector::redistribute(), oomph::DoubleMultiVector::redistribute(), oomph::DoubleVector::set_external_values(), oomph::SuperLUPreconditioner::setup(), oomph::MatrixBasedDiagPreconditioner::setup(), oomph::MatrixVectorProduct::setup(), oomph::TrilinosPreconditionerBase::setup(), oomph::MatrixBasedLumpedPreconditioner< oomph::CRDoubleMatrix >::setup(), oomph::IdentityPreconditioner::setup(), oomph::NewMumpsPreconditioner::setup(), oomph::ILUZeroPreconditioner< CCDoubleMatrix >::setup(), oomph::ILUZeroPreconditioner< CRDoubleMatrix >::setup(), oomph::InnerIterationPreconditioner< SOLVER, PRECONDITIONER >::setup(), oomph::DoubleMultiVector::shallow_build(), oomph::MumpsSolver::solve(), oomph::HSL_MA42::solve(), oomph::DenseLU::solve(), oomph::CG< MATRIX >::solve(), oomph::TrilinosAztecOOSolver::solve(), oomph::BiCGStab< MATRIX >::solve(), oomph::SuperLUSolver::solve(), oomph::GS< MATRIX >::solve(), oomph::GS< CRDoubleMatrix >::solve(), oomph::DampedJacobi< MATRIX >::solve(), oomph::GMRES< MATRIX >::solve(), oomph::HelmholtzGMRESMG< MATRIX >::solve(), oomph::HelmholtzFGMRESMG< MATRIX >::solve(), oomph::ARPACK::solve_eigenproblem(), oomph::LAPACK_QZ::solve_eigenproblem(), and oomph::TrilinosAztecOOSolver::solver_setup().

◆ build_distribution() [2/2]

void oomph::DistributableLinearAlgebraObject::build_distribution ( const LinearAlgebraDistribution dist)
inline

setup the distribution of this distributable linear algebra object

Definition at line 531 of file linear_algebra_distribution.h.

◆ clear_distribution()

void oomph::DistributableLinearAlgebraObject::clear_distribution ( )
inlineprotected

clear the distribution of this distributable linear algebra object

Definition at line 540 of file linear_algebra_distribution.h.

Referenced by oomph::DenseLU::clean_up_memory(), oomph::SuperLUSolver::clean_up_memory(), oomph::DoubleVector::clear(), and oomph::DoubleMultiVector::clear().

◆ distributed()

bool oomph::DistributableLinearAlgebraObject::distributed ( ) const
inline

distribution is serial or distributed

Definition at line 510 of file linear_algebra_distribution.h.

Referenced by oomph::PressureBasedSolidLSCPreconditioner::assemble_mass_matrix_diagonal(), oomph::HelmholtzSmoother::check_validity_of_solve_helper_inputs(), oomph::Smoother::check_validity_of_solve_helper_inputs(), oomph::DoubleVectorHelpers::concatenate(), oomph::CRDoubleMatrixHelpers::concatenate(), oomph::DoubleVectorHelpers::concatenate_without_communication(), oomph::CRDoubleMatrixHelpers::concatenate_without_communication(), oomph::TrilinosEpetraHelpers::copy_to_oomphlib_vector(), oomph::TrilinosEpetraHelpers::create_distributed_epetra_matrix(), oomph::TrilinosEpetraHelpers::create_distributed_epetra_matrix_for_aztecoo(), oomph::TrilinosEpetraHelpers::create_distributed_epetra_vector(), oomph::HypreHelpers::create_HYPRE_Matrix(), oomph::HypreHelpers::create_HYPRE_Vector(), oomph::DoubleVector::dot(), oomph::DoubleMultiVector::dot(), oomph::MumpsSolver::factorise(), oomph::SuperLUSolver::factorise_distributed(), oomph::SuperLUSolver::factorise_serial(), oomph::DoubleVector::max(), oomph::CRDoubleMatrix::multiply(), oomph::DenseDoubleMatrix::multiply(), oomph::CCDoubleMatrix::multiply(), oomph::DenseDoubleMatrix::multiply_transpose(), oomph::CCDoubleMatrix::multiply_transpose(), Anasazi::MultiVecTraits< double, oomph::DoubleMultiVector >::MvTransMv(), oomph::DoubleVector::norm(), oomph::DoubleMultiVector::norm(), oomph::DoubleVector::output(), oomph::DoubleMultiVector::output(), oomph::DoubleVector::redistribute(), oomph::DoubleMultiVector::redistribute(), oomph::AugmentedBlockFoldLinearSolver::resolve(), oomph::ILUZeroPreconditioner< CRDoubleMatrix >::setup(), oomph::FD_LU::solve(), oomph::AugmentedBlockFoldLinearSolver::solve(), oomph::AugmentedBlockPitchForkLinearSolver::solve(), oomph::BlockHopfLinearSolver::solve(), oomph::BlockHopfLinearSolver::solve_for_two_rhs(), oomph::GMRES< MATRIX >::solve_helper(), oomph::DoubleVectorHelpers::split(), and oomph::DoubleVectorHelpers::split_without_communication().

◆ distribution_built()

bool oomph::DistributableLinearAlgebraObject::distribution_built ( ) const
inline

◆ distribution_pt()

LinearAlgebraDistribution* oomph::DistributableLinearAlgebraObject::distribution_pt ( ) const
inline

access to the LinearAlgebraDistribution

Definition at line 474 of file linear_algebra_distribution.h.

Referenced by oomph::CRDoubleMatrix::add(), oomph::ProblemBasedShiftInvertOperator::apply(), oomph::OomphLibPreconditionerEpetraOperator::ApplyInverse(), oomph::MumpsSolver::backsub(), oomph::SuperLUSolver::backsub_distributed(), oomph::SuperLUSolver::backsub_serial(), oomph::DoubleVector::build(), oomph::DoubleMultiVector::build(), oomph::HelmholtzSmoother::check_validity_of_solve_helper_inputs(), oomph::Smoother::check_validity_of_solve_helper_inputs(), oomph::SuperLUSolver::clean_up_memory(), oomph::HelmholtzSmoother::complex_matrix_multiplication(), oomph::HelmholtzGMRESMG< MATRIX >::complex_matrix_multiplication(), oomph::ComplexDampedJacobi< MATRIX >::complex_solve_helper(), oomph::ComplexGMRES< MATRIX >::complex_solve_helper(), oomph::DoubleVectorHelpers::concatenate(), oomph::CRDoubleMatrixHelpers::concatenate(), oomph::DoubleVectorHelpers::concatenate_without_communication(), oomph::CRDoubleMatrixHelpers::concatenate_without_communication(), oomph::TrilinosEpetraHelpers::copy_to_oomphlib_vector(), oomph::CRDoubleMatrix::CRDoubleMatrix(), oomph::TrilinosEpetraHelpers::create_distributed_epetra_matrix(), oomph::TrilinosEpetraHelpers::create_distributed_epetra_matrix_for_aztecoo(), oomph::TrilinosEpetraHelpers::create_distributed_epetra_vector(), oomph::TrilinosEpetraHelpers::create_epetra_vector_view_data(), oomph::HypreHelpers::create_HYPRE_Matrix(), oomph::HypreHelpers::create_HYPRE_Vector(), oomph::CRDoubleMatrixHelpers::deep_copy(), oomph::DoubleVector::dot(), oomph::DoubleMultiVector::dot(), oomph::DoubleMultiVector::DoubleMultiVector(), oomph::MumpsSolver::factorise(), oomph::SuperLUSolver::factorise(), oomph::SuperLUSolver::factorise_distributed(), oomph::BlockPreconditioner< CRDoubleMatrix >::get_block_ordered_preconditioner_vector(), oomph::BlockPreconditioner< CRDoubleMatrix >::get_block_vector(), oomph::BlockPreconditioner< CRDoubleMatrix >::get_block_vectors(), oomph::BlockPreconditioner< CRDoubleMatrix >::get_concatenated_block(), oomph::BlockPreconditioner< CRDoubleMatrix >::get_concatenated_block_vector(), oomph::Problem::get_eigenproblem_matrices(), oomph::Problem::get_hessian_vector_products(), oomph::Problem::get_jacobian(), oomph::CRDoubleMatrix::get_matrix_transpose(), oomph::Problem::get_residuals(), oomph::HypreInterface::hypre_matrix_setup(), oomph::HypreInterface::hypre_solve(), oomph::BlockPreconditioner< CRDoubleMatrix >::internal_get_block(), oomph::BlockPreconditioner< CRDoubleMatrix >::internal_get_block_ordered_preconditioner_vector(), oomph::BlockPreconditioner< CRDoubleMatrix >::internal_get_block_vector(), oomph::BlockPreconditioner< CRDoubleMatrix >::internal_get_block_vectors(), oomph::BlockPreconditioner< CRDoubleMatrix >::internal_return_block_ordered_preconditioner_vector(), oomph::BlockPreconditioner< CRDoubleMatrix >::internal_return_block_vector(), oomph::BlockPreconditioner< CRDoubleMatrix >::internal_return_block_vectors(), oomph::CRDoubleMatrix::lubksub(), oomph::DoubleVector::max(), oomph::MatrixVectorProduct::multiply(), oomph::TrilinosEpetraHelpers::multiply(), oomph::CRDoubleMatrix::multiply(), oomph::DenseDoubleMatrix::multiply(), oomph::CCDoubleMatrix::multiply(), oomph::MatrixVectorProduct::multiply_transpose(), oomph::CRDoubleMatrix::multiply_transpose(), oomph::DenseDoubleMatrix::multiply_transpose(), oomph::CCDoubleMatrix::multiply_transpose(), Anasazi::MultiVecTraits< double, oomph::DoubleMultiVector >::MvTransMv(), oomph::DoubleVector::norm(), oomph::DoubleMultiVector::norm(), oomph::OomphLibPreconditionerEpetraOperator::OomphLibPreconditionerEpetraOperator(), oomph::DoubleVector::operator+=(), oomph::DoubleMultiVector::operator+=(), oomph::DoubleVector::operator-=(), oomph::DoubleMultiVector::operator-=(), oomph::DoubleVector::output(), oomph::DoubleMultiVector::output(), oomph::PitchForkHandler::PitchForkHandler(), oomph::MatrixBasedDiagPreconditioner::preconditioner_solve(), oomph::TrilinosPreconditionerBase::preconditioner_solve(), oomph::MatrixBasedLumpedPreconditioner< oomph::CRDoubleMatrix >::preconditioner_solve(), oomph::FSIPreconditioner::preconditioner_solve(), oomph::LagrangeEnforcedFlowPreconditioner::preconditioner_solve(), oomph::PressureBasedSolidLSCPreconditioner::preconditioner_solve(), oomph::IdentityPreconditioner::preconditioner_solve(), oomph::ILUZeroPreconditioner< CCDoubleMatrix >::preconditioner_solve(), oomph::ILUZeroPreconditioner< CRDoubleMatrix >::preconditioner_solve(), oomph::BlockTriangularPreconditioner< MATRIX >::preconditioner_solve(), oomph::NavierStokesSchurComplementPreconditioner::preconditioner_solve(), oomph::HyprePreconditioner::preconditioner_solve(), oomph::DoubleVector::redistribute(), oomph::DoubleMultiVector::redistribute(), oomph::MumpsSolver::resolve(), oomph::HSL_MA42::resolve(), oomph::TrilinosAztecOOSolver::resolve(), oomph::AugmentedBlockFoldLinearSolver::resolve(), oomph::BlockPitchForkLinearSolver::resolve(), oomph::HypreSolver::resolve(), oomph::BlockPreconditioner< CRDoubleMatrix >::return_block_ordered_preconditioner_vector(), oomph::BlockPreconditioner< CRDoubleMatrix >::return_block_vector(), oomph::BlockPreconditioner< CRDoubleMatrix >::return_block_vectors(), oomph::BlockPreconditioner< CRDoubleMatrix >::return_concatenated_block_vector(), oomph::BlockPreconditioner< CRDoubleMatrix >::set_replacement_dof_block(), oomph::SuperLUPreconditioner::setup(), oomph::MatrixBasedDiagPreconditioner::setup(), oomph::Preconditioner::setup(), oomph::MatrixVectorProduct::setup(), oomph::TrilinosPreconditionerBase::setup(), oomph::MatrixBasedLumpedPreconditioner< oomph::CRDoubleMatrix >::setup(), oomph::IdentityPreconditioner::setup(), oomph::NewMumpsPreconditioner::setup(), oomph::ILUZeroPreconditioner< CRDoubleMatrix >::setup(), oomph::InnerIterationPreconditioner< SOLVER, PRECONDITIONER >::setup(), oomph::HyprePreconditioner::setup(), oomph::DoubleMultiVector::setup_doublevector_representation(), oomph::DoubleMultiVector::shallow_build(), oomph::MumpsSolver::solve(), oomph::DenseLU::solve(), oomph::CG< MATRIX >::solve(), oomph::TrilinosAztecOOSolver::solve(), oomph::BiCGStab< MATRIX >::solve(), oomph::SuperLUSolver::solve(), oomph::BlockPitchForkLinearSolver::solve(), oomph::GS< MATRIX >::solve(), oomph::HypreSolver::solve(), oomph::GS< CRDoubleMatrix >::solve(), oomph::DampedJacobi< MATRIX >::solve(), oomph::GMRES< MATRIX >::solve(), oomph::HelmholtzGMRESMG< MATRIX >::solve(), oomph::HelmholtzFGMRESMG< MATRIX >::solve(), oomph::ARPACK::solve_eigenproblem(), oomph::LAPACK_QZ::solve_eigenproblem(), oomph::CG< MATRIX >::solve_helper(), oomph::BiCGStab< MATRIX >::solve_helper(), oomph::GS< MATRIX >::solve_helper(), oomph::GS< CRDoubleMatrix >::solve_helper(), oomph::DampedJacobi< MATRIX >::solve_helper(), oomph::GMRES< MATRIX >::solve_helper(), oomph::HelmholtzGMRESMG< MATRIX >::solve_helper(), oomph::HelmholtzFGMRESMG< MATRIX >::solve_helper(), oomph::TrilinosAztecOOSolver::solver_setup(), oomph::DoubleVectorHelpers::split(), oomph::DoubleVectorHelpers::split_without_communication(), oomph::LowStorageRungeKutta< ORDER >::timestep(), oomph::GMRES< MATRIX >::update(), oomph::HelmholtzGMRESMG< MATRIX >::update(), and oomph::HelmholtzFGMRESMG< MATRIX >::update().

◆ first_row() [1/2]

unsigned oomph::DistributableLinearAlgebraObject::first_row ( ) const
inline

◆ first_row() [2/2]

unsigned oomph::DistributableLinearAlgebraObject::first_row ( const unsigned &  p) const
inline

access function for the first row on this processor

Definition at line 504 of file linear_algebra_distribution.h.

◆ nrow()

unsigned oomph::DistributableLinearAlgebraObject::nrow ( ) const
inline

access function to the number of global rows.

Definition at line 480 of file linear_algebra_distribution.h.

Referenced by oomph::IMRByBDF::actions_after_timestep(), oomph::Problem::add_eigenvector_to_dofs(), oomph::PressureBasedSolidLSCPreconditioner::assemble_mass_matrix_diagonal(), oomph::Problem::assign_eigenvector_to_dofs(), oomph::DenseLU::backsub(), oomph::SuperLUSolver::backsub_serial(), oomph::BlockPreconditioner< CRDoubleMatrix >::block_matrix_test(), oomph::HelmholtzSmoother::check_validity_of_solve_helper_inputs(), oomph::Smoother::check_validity_of_solve_helper_inputs(), oomph::ComplexGMRES< MATRIX >::complex_smoother_setup(), oomph::ComplexGMRES< MATRIX >::complex_solve_helper(), oomph::DoubleVectorHelpers::concatenate(), oomph::TrilinosEpetraHelpers::create_distributed_epetra_vector(), oomph::SuperLUSolver::factorise_distributed(), Anasazi::MultiVecTraits< double, oomph::DoubleMultiVector >::GetVecLength(), oomph::DoubleVector::initialise(), oomph::BlockPreconditioner< CRDoubleMatrix >::internal_get_block_vector(), oomph::DoubleVector::max(), oomph::DenseDoubleMatrix::multiply(), oomph::CCDoubleMatrix::multiply(), oomph::DenseDoubleMatrix::multiply_transpose(), oomph::CCDoubleMatrix::multiply_transpose(), oomph::CRDoubleMatrix::nrow(), oomph::DoubleVector::output(), oomph::DoubleMultiVector::output(), oomph::LagrangeEnforcedFlowPreconditioner::preconditioner_solve(), oomph::PressureBasedSolidLSCPreconditioner::preconditioner_solve(), oomph::ILUZeroPreconditioner< CCDoubleMatrix >::preconditioner_solve(), oomph::ILUZeroPreconditioner< CRDoubleMatrix >::preconditioner_solve(), oomph::MGPreconditioner< DIM >::preconditioner_solve(), oomph::NavierStokesSchurComplementPreconditioner::preconditioner_solve(), oomph::DoubleVector::redistribute(), oomph::DoubleMultiVector::redistribute(), oomph::HSL_MA42::resolve(), oomph::TrilinosAztecOOSolver::resolve(), oomph::Problem::set_dofs(), oomph::TrilinosPreconditionerBase::setup(), oomph::InnerIterationPreconditioner< SOLVER, PRECONDITIONER >::setup(), oomph::MumpsSolver::solve(), oomph::DenseLU::solve(), oomph::FD_LU::solve(), oomph::TrilinosAztecOOSolver::solve(), oomph::SuperLUSolver::solve(), oomph::CG< MATRIX >::solve_helper(), oomph::BiCGStab< MATRIX >::solve_helper(), oomph::GS< MATRIX >::solve_helper(), oomph::GS< CRDoubleMatrix >::solve_helper(), oomph::DampedJacobi< MATRIX >::solve_helper(), oomph::GMRES< MATRIX >::solve_helper(), oomph::HelmholtzGMRESMG< MATRIX >::solve_helper(), oomph::HelmholtzFGMRESMG< MATRIX >::solve_helper(), oomph::DoubleVectorHelpers::split(), oomph::LowStorageRungeKutta< ORDER >::timestep(), and oomph::GMRES< MATRIX >::update().

◆ nrow_local() [1/2]

unsigned oomph::DistributableLinearAlgebraObject::nrow_local ( ) const
inline

access function for the num of local rows on this processor.

Definition at line 486 of file linear_algebra_distribution.h.

Referenced by oomph::Problem::add_eigenvector_to_dofs(), oomph::ProblemBasedShiftInvertOperator::apply(), oomph::PressureBasedSolidLSCPreconditioner::assemble_mass_matrix_diagonal(), oomph::Problem::assign_eigenvector_to_dofs(), oomph::DoubleVector::build(), oomph::DoubleMultiVector::build(), oomph::TrilinosEpetraHelpers::copy_to_oomphlib_vector(), oomph::CRDoubleMatrix::CRDoubleMatrix(), oomph::TrilinosEpetraHelpers::create_distributed_epetra_matrix_for_aztecoo(), oomph::CRDoubleMatrixHelpers::deep_copy(), oomph::DoubleVector::dot(), oomph::DoubleMultiVector::dot(), oomph::DoubleMultiVector::DoubleMultiVector(), oomph::SuperLUSolver::factorise_distributed(), oomph::Problem::get_derivative_wrt_global_parameter(), oomph::DoubleVector::initialise(), oomph::DoubleMultiVector::initialise(), oomph::PseudoElasticPreconditioner::lagrange_multiplier_preconditioner_solve(), oomph::PseudoElasticPreconditionerOld::lagrange_multiplier_preconditioner_solve(), oomph::DoubleVector::max(), oomph::TrilinosEpetraHelpers::multiply(), Anasazi::MultiVecTraits< double, oomph::DoubleMultiVector >::MvAddMv(), Anasazi::MultiVecTraits< double, oomph::DoubleMultiVector >::MvRandom(), Anasazi::MultiVecTraits< double, oomph::DoubleMultiVector >::MvScale(), Anasazi::MultiVecTraits< double, oomph::DoubleMultiVector >::MvTimesMatAddMv(), Anasazi::MultiVecTraits< double, oomph::DoubleMultiVector >::MvTransMv(), oomph::DoubleVector::norm(), oomph::DoubleMultiVector::norm(), oomph::DoubleMultiVector::operator()(), oomph::DoubleVector::operator*=(), oomph::DoubleMultiVector::operator*=(), oomph::DoubleVector::operator+=(), oomph::DoubleMultiVector::operator+=(), oomph::DoubleVector::operator-=(), oomph::DoubleMultiVector::operator-=(), oomph::DoubleVector::operator==(), oomph::DoubleMultiVector::operator==(), oomph::DoubleVector::operator[](), oomph::DoubleVector::output(), oomph::DoubleMultiVector::output(), oomph::DoubleVector::output_local_values(), oomph::DoubleVector::output_local_values_with_offset(), oomph::MatrixBasedDiagPreconditioner::preconditioner_solve(), oomph::LagrangeEnforcedFlowPreconditioner::preconditioner_solve(), oomph::DoubleVector::redistribute(), oomph::DoubleMultiVector::redistribute(), oomph::DoubleMatrixBase::residual(), oomph::BlockPitchForkLinearSolver::resolve(), Anasazi::MultiVecTraits< double, oomph::DoubleMultiVector >::SetBlock(), oomph::MatrixBasedDiagPreconditioner::setup(), oomph::MatrixBasedLumpedPreconditioner< oomph::CRDoubleMatrix >::setup(), oomph::PseudoElasticPreconditionerSubsidiaryPreconditionerOld::setup(), oomph::HyprePreconditioner::setup(), oomph::FD_LU::solve(), oomph::BlockPitchForkLinearSolver::solve(), and oomph::DoubleVectorHelpers::split().

◆ nrow_local() [2/2]

unsigned oomph::DistributableLinearAlgebraObject::nrow_local ( const unsigned &  p) const
inline

access function for the num of local rows on this processor.

Definition at line 492 of file linear_algebra_distribution.h.

◆ operator=()

void oomph::DistributableLinearAlgebraObject::operator= ( const DistributableLinearAlgebraObject )
inline

Broken assignment operator.

Definition at line 462 of file linear_algebra_distribution.h.

References oomph::BrokenCopy::broken_assign().

Member Data Documentation

◆ Distribution_pt

LinearAlgebraDistribution* oomph::DistributableLinearAlgebraObject::Distribution_pt
private

the LinearAlgebraDistribution object

Definition at line 548 of file linear_algebra_distribution.h.


The documentation for this class was generated from the following file: