Tpetra parallel linear algebra Version of the Day
Loading...
Searching...
No Matches
Namespaces | Functions
Tpetra_computeRowAndColumnOneNorms_def.hpp File Reference

Definition of Tpetra::computeRowAndColumnOneNorms. More...

#include "Tpetra_Details_copyConvert.hpp"
#include "Tpetra_CrsMatrix.hpp"
#include "Tpetra_Export.hpp"
#include "Tpetra_Map.hpp"
#include "Tpetra_MultiVector.hpp"
#include "Tpetra_RowMatrix.hpp"
#include "Kokkos_Core.hpp"
#include "Teuchos_CommHelpers.hpp"
#include <memory>

Go to the source code of this file.

Namespaces

namespace  Tpetra
 Namespace Tpetra contains the class and methods constituting the Tpetra library.
 
namespace  Tpetra::Details
 Nonmember function that computes a residual Computes R = B - A * X.
 

Functions

template<class SC , class LO , class GO , class NT >
void Tpetra::Details::computeLocalRowScaledColumnNorms_RowMatrix (EquilibrationInfo< typename Kokkos::ArithTraits< SC >::val_type, typename NT::device_type > &result, const Tpetra::RowMatrix< SC, LO, GO, NT > &A)
 For a given Tpetra::RowMatrix that is not a Tpetra::CrsMatrix, assume that result.rowNorms has been computed (and globalized), and compute result.rowScaledColNorms.
 
template<class SC , class LO , class GO , class NT >
EquilibrationInfo< typename Kokkos::ArithTraits< SC >::val_type, typename NT::device_type > Tpetra::Details::computeLocalRowOneNorms_RowMatrix (const Tpetra::RowMatrix< SC, LO, GO, NT > &A)
 Implementation of computeLocalRowOneNorms for a Tpetra::RowMatrix that is NOT a Tpetra::CrsMatrix.
 
template<class SC , class LO , class GO , class NT >
EquilibrationInfo< typename Kokkos::ArithTraits< SC >::val_type, typename NT::device_type > Tpetra::Details::computeLocalRowAndColumnOneNorms_RowMatrix (const Tpetra::RowMatrix< SC, LO, GO, NT > &A, const bool assumeSymmetric)
 Implementation of computeLocalRowAndColumnOneNorms for a Tpetra::RowMatrix that is NOT a Tpetra::CrsMatrix.
 
template<class SC , class LO , class GO , class NT >
EquilibrationInfo< typename Kokkos::ArithTraits< SC >::val_type, typename NT::device_type > Tpetra::Details::computeLocalRowOneNorms_CrsMatrix (const Tpetra::CrsMatrix< SC, LO, GO, NT > &A)
 Implementation of computeLocalRowOneNorms for a Tpetra::CrsMatrix.
 
template<class SC , class LO , class GO , class NT >
EquilibrationInfo< typename Kokkos::ArithTraits< SC >::val_type, typename NT::device_type > Tpetra::Details::computeLocalRowAndColumnOneNorms_CrsMatrix (const Tpetra::CrsMatrix< SC, LO, GO, NT > &A, const bool assumeSymmetric)
 Implementation of computeLocalRowAndColumnOneNorms for a Tpetra::CrsMatrix.
 
template<class SC , class LO , class GO , class NT >
EquilibrationInfo< typename Kokkos::ArithTraits< SC >::val_type, typename NT::device_type > Tpetra::Details::computeLocalRowOneNorms (const Tpetra::RowMatrix< SC, LO, GO, NT > &A)
 Compute LOCAL row one-norms ("row sums" etc.) of the input sparse matrix A.
 
template<class SC , class LO , class GO , class NT >
EquilibrationInfo< typename Kokkos::ArithTraits< SC >::val_type, typename NT::device_type > Tpetra::Details::computeLocalRowAndColumnOneNorms (const Tpetra::RowMatrix< SC, LO, GO, NT > &A, const bool assumeSymmetric)
 Compute LOCAL row and column one-norms ("row sums" etc.) of the input sparse matrix A. Optionally, also compute row-scaled column norms (in the manner of LAPACK's DGEEQU routine).
 
template<class SC , class LO , class GO , class NT >
Details::EquilibrationInfo< typename Kokkos::ArithTraits< SC >::val_type, typename NT::device_type > Tpetra::computeRowOneNorms (const Tpetra::RowMatrix< SC, LO, GO, NT > &A)
 Compute global row one-norms ("row sums") of the input sparse matrix A, in a way suitable for one-sided (left only) equilibration.
 
template<class SC , class LO , class GO , class NT >
Details::EquilibrationInfo< typename Kokkos::ArithTraits< SC >::val_type, typename NT::device_type > Tpetra::computeRowAndColumnOneNorms (const Tpetra::RowMatrix< SC, LO, GO, NT > &A, const bool assumeSymmetric)
 Compute global row and column one-norms ("row sums" and "column sums") of the input sparse matrix A, in a way suitable for two-sided (left and right) equilibration.
 

Detailed Description

Definition of Tpetra::computeRowAndColumnOneNorms.

For the declaration of this function and its public Doxygen documentation, please see Tpetra_computeRowAndColumnOneNorms_decl.hpp in this directory.

Definition in file Tpetra_computeRowAndColumnOneNorms_def.hpp.