19#ifndef AMESOS2_EPETRAROWMATRIX_ABSTRACTMATRIXADAPTER_DEF_HPP 
   20#define AMESOS2_EPETRAROWMATRIX_ABSTRACTMATRIXADAPTER_DEF_HPP 
   22#include <Epetra_RowMatrix.h> 
   23#include <Epetra_Map.h> 
   24#include <Epetra_Comm.h> 
   32  using Teuchos::ArrayView;
 
   34  template <
class DerivedMat>
 
   35  AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>::AbstractConcreteMatrixAdapter(RCP<DerivedMat> m)
 
   36      : MatrixAdapter<DerivedMat>(m)
 
   42  template <
class DerivedMat>
 
   44  AbstractConcreteMatrixAdapter<
 
   46    DerivedMat>::getGlobalRowCopy_impl(global_ordinal_t row,
 
   47                                       const ArrayView<global_ordinal_t>& indices,
 
   48                                       const ArrayView<scalar_t>& vals,
 
   52    const int local_row = this->row_map_->getLocalElement(row);
 
   55    Teuchos::Array<local_ordinal_t> epetra_lcl_inds_buf;
 
   56    Teuchos::ArrayView<local_ordinal_t> epetra_lcl_inds;
 
   57    if (! std::is_same<global_ordinal_t, local_ordinal_t>::value) {
 
   61        err = this->mat_->NumMyRowEntries (local_row, num_ent);
 
   63      catch (
int integer_exception) {
 
   65        err = integer_exception;
 
   67      TEUCHOS_TEST_FOR_EXCEPTION
 
   68        (threw && err != 0, std::runtime_error, 
"Epetra_RowMatrix::" 
   69         "NumMyRowEntries, called on local row " << local_row << 
", threw " 
   70         "an integer exception " << err << 
".");
 
   71      TEUCHOS_TEST_FOR_EXCEPTION
 
   72        (! threw && err != 0, std::runtime_error, 
"Epetra_RowMatrix returned " 
   73         "error code " << err << 
" from NumMyRowEntries for local row " 
   75      epetra_lcl_inds_buf.resize (num_ent);
 
   76      epetra_lcl_inds = epetra_lcl_inds_buf ();
 
   79      using Teuchos::av_reinterpret_cast;
 
   80      epetra_lcl_inds = av_reinterpret_cast<int> (indices);
 
   84    int rowmatrix_return_val = 0;
 
   86      rowmatrix_return_val =
 
   87        this->mat_->ExtractMyRowCopy(local_row,
 
   88                                     as<int>(std::min(epetra_lcl_inds.size(), vals.size())),
 
   91                                     epetra_lcl_inds.getRawPtr());
 
   93    catch (
int integer_exception) {
 
   95      rowmatrix_return_val = integer_exception;
 
   97    TEUCHOS_TEST_FOR_EXCEPTION
 
   98      (threw && rowmatrix_return_val != 0, std::runtime_error,
 
   99       "Epetra_RowMatrix::ExtractMyRowCopy, called on local row " << local_row
 
  100       << 
", threw an integer exception " << rowmatrix_return_val << 
".");
 
  101    TEUCHOS_TEST_FOR_EXCEPTION
 
  102      (! threw && rowmatrix_return_val != 0, std::runtime_error,
 
  103       "Epetra_RowMatrix object returned error code " 
  104       << rowmatrix_return_val << 
" from ExtractMyRowCopy." );
 
  105    nnz = as<size_t>(nnz_ret);
 
  109    for( 
size_t i = 0; i < nnz; ++i ){
 
  110      indices[i] = this->col_map_->getGlobalElement(epetra_lcl_inds[i]);
 
  114  template <
class DerivedMat>
 
  116  AbstractConcreteMatrixAdapter<
 
  118    DerivedMat>::getGlobalColCopy_impl(global_ordinal_t col,
 
  119                                       const ArrayView<global_ordinal_t>& indices,
 
  120                                       const ArrayView<scalar_t>& vals,
 
  123    TEUCHOS_TEST_FOR_EXCEPTION( 
true,
 
  125                        "Column access to row-based object not yet supported.  " 
  126                        "Please contact the Amesos2 developers." );
 
  130  template <
class DerivedMat>
 
  131  template<
typename KV_GO, 
typename KV_S>
 
  133  AbstractConcreteMatrixAdapter<
 
  135    DerivedMat>::getGlobalRowCopy_kokkos_view_impl(global_ordinal_t row,
 
  140    using index_t = 
typename KV_GO::value_type;
 
  141    using value_t = 
typename KV_S::value_type;
 
  142    ArrayView<value_t>  vals_array    (vals.data(),    vals.extent(0));
 
  143    ArrayView<index_t>  indices_array (indices.data(), indices.extent(0));
 
  145    this->getGlobalRowCopy_impl(row, indices_array, vals_array, nnz);
 
  150  template <
class DerivedMat>
 
  151  typename AbstractConcreteMatrixAdapter<
 
  153    DerivedMat>::global_size_t
 
  154  AbstractConcreteMatrixAdapter<
 
  156    DerivedMat>::getGlobalNNZ_impl()
 const 
  158    return Teuchos::as<global_size_t>(this->mat_->NumGlobalNonzeros());
 
  161  template <
class DerivedMat>
 
  163  AbstractConcreteMatrixAdapter<
 
  165    DerivedMat>::getLocalNNZ_impl()
 const 
  167    return Teuchos::as<size_t>(this->mat_->NumMyNonzeros());
 
  170  template <
class DerivedMat>
 
  171  typename AbstractConcreteMatrixAdapter<
 
  173    DerivedMat>::global_size_t
 
  174  AbstractConcreteMatrixAdapter<
 
  176    DerivedMat>::getGlobalNumRows_impl()
 const 
  178    return Teuchos::as<global_size_t>(this->mat_->NumGlobalRows());
 
  181  template <
class DerivedMat>
 
  182  typename AbstractConcreteMatrixAdapter<
 
  184    DerivedMat>::global_size_t
 
  185  AbstractConcreteMatrixAdapter<
 
  187    DerivedMat>::getGlobalNumCols_impl()
 const 
  189    return Teuchos::as<global_size_t>(this->mat_->NumGlobalCols());
 
  192  template <
class DerivedMat>
 
  194  AbstractConcreteMatrixAdapter<
 
  196    DerivedMat>::getMaxRowNNZ_impl()
 const 
  198    return Teuchos::as<size_t>(this->mat_->MaxNumEntries());
 
  201  template <
class DerivedMat>
 
  203  AbstractConcreteMatrixAdapter<
 
  205    DerivedMat>::getMaxColNNZ_impl()
 const 
  207    TEUCHOS_TEST_FOR_EXCEPTION( 
true,
 
  209                        "Column access to row-based object not yet supported.  " 
  210                        "Please contact the Amesos2 developers." );
 
  213  template <
class DerivedMat>
 
  215  AbstractConcreteMatrixAdapter<
 
  217    DerivedMat>::getGlobalRowNNZ_impl(global_ordinal_t row)
 const 
  220    Epetra_Map rowmap = this->mat_->RowMatrixRowMap();
 
  221    int gid = Teuchos::as<int>(row);
 
  222    TEUCHOS_TEST_FOR_EXCEPTION( !rowmap.MyGID(gid),
 
  223                        std::invalid_argument,
 
  224                        "The specified global row id does not belong to me" );
 
  225    int lid = rowmap.LID(gid);
 
  227    this->mat_->NumMyRowEntries(lid, nnz);
 
  231  template <
class DerivedMat>
 
  233  AbstractConcreteMatrixAdapter<
 
  235    DerivedMat>::getLocalRowNNZ_impl(local_ordinal_t row)
 const 
  237    Epetra_Map rowmap = this->mat_->RowMatrixRowMap();
 
  238    int lid = Teuchos::as<int>(row);
 
  239    TEUCHOS_TEST_FOR_EXCEPTION( !rowmap.MyLID(lid),
 
  240                        std::invalid_argument,
 
  241                        "The specified local row id does not beloing to me" );
 
  243    this->mat_->NumMyRowEntries(row, num_entries);
 
  247  template <
class DerivedMat>
 
  249  AbstractConcreteMatrixAdapter<
 
  251    DerivedMat>::getGlobalColNNZ_impl(global_ordinal_t col)
 const 
  253    TEUCHOS_TEST_FOR_EXCEPTION( 
true,
 
  255                        "Column access to row-based object not yet supported.  " 
  256                        "Please contact the Amesos2 developers." );
 
  259  template <
class DerivedMat>
 
  261  AbstractConcreteMatrixAdapter<
 
  263    DerivedMat>::getLocalColNNZ_impl(local_ordinal_t col)
 const 
  265    TEUCHOS_TEST_FOR_EXCEPTION( 
true,
 
  267                        "Column access to row-based object not yet supported.  " 
  268                        "Please contact the Amesos2 developers." );
 
  271  template <
class DerivedMat>
 
  272  const RCP<const Tpetra::Map<MatrixTraits<Epetra_RowMatrix>::local_ordinal_t,
 
  273                              MatrixTraits<Epetra_RowMatrix>::global_ordinal_t,
 
  274                              MatrixTraits<Epetra_RowMatrix>::node_t> >
 
  275  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::getMap_impl()
 const 
  277    const Epetra_BlockMap map = this->mat_->Map();
 
  278    return( Util::epetra_map_to_tpetra_map<local_ordinal_t,global_ordinal_t,global_size_t,node_t>(map) );
 
  281  template <
class DerivedMat>
 
  282  const RCP<const Tpetra::Map<MatrixTraits<Epetra_RowMatrix>::local_ordinal_t,
 
  283                              MatrixTraits<Epetra_RowMatrix>::global_ordinal_t,
 
  284                              MatrixTraits<Epetra_RowMatrix>::node_t> >
 
  285  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::getRowMap_impl()
 const 
  288    const Epetra_Map rowmap = this->mat_->RowMatrixRowMap();
 
  289    return( Util::epetra_map_to_tpetra_map<local_ordinal_t,global_ordinal_t,global_size_t,node_t>(rowmap) );
 
  292  template <
class DerivedMat>
 
  293  const RCP<const Tpetra::Map<MatrixTraits<Epetra_RowMatrix>::local_ordinal_t,
 
  294                              MatrixTraits<Epetra_RowMatrix>::global_ordinal_t,
 
  295                              MatrixTraits<Epetra_RowMatrix>::node_t> >
 
  296  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::getColMap_impl()
 const 
  299    const Epetra_Map colmap = this->mat_->RowMatrixColMap();
 
  300    return( Util::epetra_map_to_tpetra_map<local_ordinal_t,global_ordinal_t,global_size_t,node_t>(colmap) );
 
  303  template <
class DerivedMat>
 
  304  const RCP<const Teuchos::Comm<int> >
 
  305  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::getComm_impl()
 const 
  307    return Util::to_teuchos_comm(Teuchos::rcpFromRef(this->mat_->Comm()));
 
  310  template <
class DerivedMat>
 
  312  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::isLocallyIndexed_impl()
 const 
  314    return this->mat_->IndicesAreLocal();
 
  317  template <
class DerivedMat>
 
  319  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::isGloballyIndexed_impl()
 const 
  321    return this->mat_->IndicesAreGlobal();
 
  325  template <
class DerivedMat>
 
  326  RCP<const MatrixAdapter<DerivedMat> >
 
  327  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::get_impl(
const Teuchos::Ptr<
const Tpetra::Map<local_ordinal_t,global_ordinal_t,node_t> > map, EDistribution distribution)
 const 
  332    return dynamic_cast<ConcreteMatrixAdapter<DerivedMat>*
>(
this)->get_impl(map, distribution);
 
  334    return static_cast<ConcreteMatrixAdapter<DerivedMat>*
>(
this)->get_impl(map, distribution);
 
  338  template <
class DerivedMat>
 
  339  RCP<const MatrixAdapter<DerivedMat> >
 
  340  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::reindex_impl(Teuchos::RCP<const map_t> &contigRowMap,
 
  341                                                                            Teuchos::RCP<const map_t> &contigColMap,
 
  342                                                                            const EPhase current_phase)
 const 
  347    return dynamic_cast<ConcreteMatrixAdapter<DerivedMat>*
>(
this)->reindex_impl(contigRowMap, contigColMap, current_phase);
 
  349    return static_cast<ConcreteMatrixAdapter<DerivedMat>*
>(
this)->reindex_impl(contigRowMap, contigColMap, current_phase);
 
  353  template <
class DerivedMat>
 
  354  template<
typename KV_S, 
typename KV_GO, 
typename KV_GS, 
typename host_ordinal_type_array, 
typename host_scalar_type_array>
 
  355  typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::local_ordinal_t
 
  356  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::gather_impl(KV_S& nzvals, KV_GO& indices, KV_GS& pointers,
 
  357                                host_ordinal_type_array &perm_g2l,
 
  358                                host_ordinal_type_array &recvCountRows, host_ordinal_type_array &recvDisplRows,
 
  359                                host_ordinal_type_array &recvCounts, host_ordinal_type_array &recvDispls,
 
  360                                host_ordinal_type_array &transpose_map, host_scalar_type_array &nzvals_t,
 
  361                                bool column_major, EPhase current_phase)
 const 
  365    return dynamic_cast<ConcreteMatrixAdapter<DerivedMat>*
>(
this)->gather_impl(nzvals, indices, pointers, perm_g2l, recvCounts, recvDispls, recvCountRows, recvDisplRows,
 
  366                                                                               transpose_map, nzvals_t, column_major, current_phase);
 
  368    return static_cast<ConcreteMatrixAdapter<DerivedMat>*
>(
this)->gather_impl(nzvals, indices, pointers, perm_g2l, recvCounts, recvDispls, recvCountRows, recvDisplRows,
 
  369                                                                              transpose_map, nzvals_t, column_major, current_phase);
 
  373  template <
class DerivedMat>
 
  374  typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>
 
  376  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::getSparseRowPtr()
 const 
  378    typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>::spmtx_ptr_t  sp_rowptr = 
nullptr;
 
  379    typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>::spmtx_idx_t  sp_colind = 
nullptr;
 
  380    typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>::spmtx_val_t  sp_values = 
nullptr;
 
  382    this->mat_->ExtractCrsDataPointers(sp_rowptr, sp_colind, sp_values);
 
  387  template <
class DerivedMat>
 
  388  typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>
 
  390  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::getSparseColInd()
 const 
  392    typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>::spmtx_ptr_t  sp_rowptr = 
nullptr;
 
  393    typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>::spmtx_idx_t  sp_colind = 
nullptr;
 
  394    typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>::spmtx_val_t  sp_values = 
nullptr;
 
  396    this->mat_->ExtractCrsDataPointers(sp_rowptr, sp_colind, sp_values);
 
  401  template <
class DerivedMat>
 
  402  typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>
 
  404  AbstractConcreteMatrixAdapter<Epetra_RowMatrix, DerivedMat>::getSparseValues()
 const 
  406    typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>::spmtx_ptr_t  sp_rowptr = 
nullptr;
 
  407    typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>::spmtx_idx_t  sp_colind = 
nullptr;
 
  408    typename AbstractConcreteMatrixAdapter<Epetra_RowMatrix,DerivedMat>::spmtx_val_t  sp_values = 
nullptr;
 
  410    this->mat_->ExtractCrsDataPointers(sp_rowptr, sp_colind, sp_values);
 
Provides the Epetra_RowMatrix abstraction for the concrete Epetra row matric adapters.