Skip to content

Commit

Permalink
Merge 'trilinos/Trilinos:develop' (9ef3d88) into 'tcad-charon/Trilino…
Browse files Browse the repository at this point in the history
…s:develop' (28dc31d).

* trilinos-develop: (36 commits)
  MueLu: Adding support for driving Galeri options via ParameterList in Driver
  MueLu: Adding support for driving Galeri options via ParameterList in Driver
  MueLu: Adding support for driving Galeri options via ParameterList in Driver
  Tpetra:   deprecate and remove use of StaticProfile (trilinos#9865)
  packages/framework: Fix typo
  cmake/std/atdm: Fix typo
  MueLu: Derive HierarchicalOperator from RowMatrix
  MueLu: Construct Ifpack2Smoother using Operator instead of Matrix
  MueLu: fix ReitzingerPFactory for non-UVM
  MueLu: Rebase gold files
  MueLu: Simplify passing precomputed objects
  Disable override of Sacado_NEW_FAD_DESIGN_IS_DEFAULT with PR tester
  MueLu: remove Tpetra deprecated from Region
  MueLu: remove dependence on Tpetra deprecated
  Tpetra: AsyncTransfer test cleanup: remove shouldSkipTest, fix maps, simplify MultiVector result check
  Tpetra: fix template parameter ordering in AsyncTransfer for consistency
  Tpetra: clean up includes/typedefs/setup functions for AsyncTransfer tests
  MueLu: Add test driver for hierarchical matrices
  STK: Updated snapshot 10-21-21 11:21
  Percept changes needed for stk entity-rank changes.
  ...
  • Loading branch information
Charonops Jenkins Pipeline committed Oct 28, 2021
2 parents 28dc31d + 9ef3d88 commit 3f8d0b6
Show file tree
Hide file tree
Showing 269 changed files with 130,326 additions and 4,811 deletions.
4 changes: 3 additions & 1 deletion cmake/std/PullRequestLinuxCuda10.1.105TestingSettings.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -78,7 +78,9 @@ set (TPL_DLlib_LIBRARIES "-ldl" CACHE FILEPATH "Set by default for CUDA PR testi
# The compile times for two Panzer files went up to over 6 hours. This
# turns off one feature that allows these in about 24 minutes. Please remove
# when issue #7532 is resolved.
set (Sacado_NEW_FAD_DESIGN_IS_DEFAULT OFF CACHE BOOL "Temporary fix for issue #7532" )
# Compile time issues addressed by #8377. Commenting out the override of
# Sacado_NEW_FAD_DESIGN_IS_DEFAULT to return to default settings.
#set (Sacado_NEW_FAD_DESIGN_IS_DEFAULT OFF CACHE BOOL "Temporary fix for issue #7532" )

# Disable some packages that can't be tested with this PR build
set (Trilinos_ENABLE_ShyLU_NodeTacho OFF CACHE BOOL
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -77,7 +77,9 @@ set (TPL_DLlib_LIBRARIES "-ldl" CACHE FILEPATH "Set by default for CUDA PR testi
# The compile times for two Panzer files went up to over 6 hours. This
# turns off one feature that allows these in about 24 minutes. Please remove
# when issue #7532 is resolved.
set (Sacado_NEW_FAD_DESIGN_IS_DEFAULT OFF CACHE BOOL "Temporary fix for issue #7532" )
# Compile time issues addressed by #8377. Commenting out the override of
# Sacado_NEW_FAD_DESIGN_IS_DEFAULT to return to default settings.
#set (Sacado_NEW_FAD_DESIGN_IS_DEFAULT OFF CACHE BOOL "Temporary fix for issue #7532" )

# Disable some packages that can't be tested with this PR build
set (Trilinos_ENABLE_ShyLU_NodeTacho OFF CACHE BOOL
Expand Down
4 changes: 3 additions & 1 deletion cmake/std/PullRequestLinuxCuda10.1.243TestingSettings.cmake
Original file line number Diff line number Diff line change
Expand Up @@ -84,7 +84,9 @@ set (TPL_DLlib_LIBRARIES "-ldl" CACHE FILEPATH "Set by default for CUDA PR testi
# The compile times for two Panzer files went up to over 6 hours. This
# turns off one feature that allows these in about 24 minutes. Please remove
# when issue #7532 is resolved.
set (Sacado_NEW_FAD_DESIGN_IS_DEFAULT OFF CACHE BOOL "Temporary fix for issue #7532" )
# Compile time issues addressed by #8377. Commenting out the override of
# Sacado_NEW_FAD_DESIGN_IS_DEFAULT to return to default settings.
#set (Sacado_NEW_FAD_DESIGN_IS_DEFAULT OFF CACHE BOOL "Temporary fix for issue #7532" )

# Disable some packages that can't be tested with this PR build
set (Trilinos_ENABLE_ShyLU_NodeTacho OFF CACHE BOOL
Expand Down
2 changes: 1 addition & 1 deletion cmake/std/atdm/README.md
Original file line number Diff line number Diff line change
Expand Up @@ -1572,7 +1572,7 @@ each system</a>.
These contributed configurations are used just like any other custom
configuration as described in <a
href="#custom-systems-and-configurations">Custom systems and
configurations</a>.. For example, to load the contributed custom 'weaver'
configurations</a>. For example, to load the contributed custom 'weaver'
configuration to do a CUDA optimized build, do:

```
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -197,7 +197,7 @@ namespace {
// create a Map
const size_t numLocal = 10;
RCP<Map<LO,GO,Node> > map = rcp( new Map<LO,GO,Node>(INVALID,numLocal,0,comm) );
RCP<MAT> eye = rcp( new MAT(map,1,Tpetra::StaticProfile) );
RCP<MAT> eye = rcp( new MAT(map,1) );
GO base = numLocal*rank;
for( size_t i = 0; i < numLocal; ++i ){
eye->insertGlobalValues(base+i,tuple<GO>(base+i),tuple<Scalar>(ST::one()));
Expand Down Expand Up @@ -230,7 +230,7 @@ namespace {
// create a Map
const size_t numLocal = 10;
RCP<Map<LO,GO,Node> > map = rcp( new Map<LO,GO,Node>(INVALID,numLocal,0,comm) );
RCP<MAT> eye = rcp( new MAT(map,1,Tpetra::StaticProfile) );
RCP<MAT> eye = rcp( new MAT(map,1) );
GO base = numLocal*rank;
for( size_t i = 0; i < numLocal; ++i ){
eye->insertGlobalValues(base+i,tuple<GO>(base+i),tuple<Scalar>(ST::one()));
Expand Down
2 changes: 1 addition & 1 deletion packages/amesos2/test/solvers/SolverFactory.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -124,7 +124,7 @@ namespace {
const size_t maxNumEntPerRow = 3;
const SC two = static_cast<SC> (2.0);
const SC minusOne = static_cast<SC> (-1.0);
RCP<MAT> A (new MAT (rowMap, maxNumEntPerRow, Tpetra::StaticProfile));
RCP<MAT> A (new MAT (rowMap, maxNumEntPerRow));

if (rowMap->getNodeNumElements () != 0) {
for (LO lclRow = rowMap->getMinLocalIndex ();
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -117,7 +117,7 @@ int main(int argc, char *argv[])

// create map
RCP<const Map<> > map = rcp (new Map<> (dim,0,comm));
RCP<CrsMatrix<ST> > K = rcp (new CrsMatrix<ST> (map, 4, Tpetra::StaticProfile));
RCP<CrsMatrix<ST> > K = rcp (new CrsMatrix<ST> (map, 4));
int base = MyPID*ROWS_PER_PROC;
if (MyPID != NumImages-1) {
for (int i=0; i<ROWS_PER_PROC; ++i) {
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -119,7 +119,7 @@ int main(int argc, char *argv[])

// create map
RCP<const Map<> > map = rcp (new Map<> (dim,0,comm));
RCP<CrsMatrix<ST> > K = rcp (new CrsMatrix<ST> (map, 4, Tpetra::StaticProfile));
RCP<CrsMatrix<ST> > K = rcp (new CrsMatrix<ST> (map, 4));
int base = MyPID*ROWS_PER_PROC;
if (MyPID != NumImages-1) {
for (int i=0; i<ROWS_PER_PROC; ++i) {
Expand Down
2 changes: 1 addition & 1 deletion packages/anasazi/tpetra/test/IRTR/cxx_main_lap.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -120,7 +120,7 @@ int main(int argc, char *argv[])

// create map
RCP<const Map<> > map = rcp (new Map<> (dim, 0, comm));
RCP<CrsMatrix<ST> > K = rcp(new CrsMatrix<ST>(map,4,Tpetra::StaticProfile));
RCP<CrsMatrix<ST> > K = rcp(new CrsMatrix<ST>(map,4));
int base = MyPID*ROWS_PER_PROC;
if (MyPID != NumImages-1) {
for (int i=0; i<ROWS_PER_PROC; ++i) {
Expand Down
2 changes: 1 addition & 1 deletion packages/anasazi/tpetra/test/MVOPTester/cxx_main.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -102,7 +102,7 @@ namespace { // (anonymous)
template<class Scalar, class O1, class O2>
RCP<CrsMatrix<Scalar,O1,O2,Node> > constructDiagMatrix(const RCP<const Map<O1,O2,Node> > &map)
{
RCP<CrsMatrix<Scalar,O1,O2,Node> > op = rcp( new CrsMatrix<Scalar,O1,O2,Node>(map,1,Tpetra::StaticProfile) );
RCP<CrsMatrix<Scalar,O1,O2,Node> > op = rcp( new CrsMatrix<Scalar,O1,O2,Node>(map,1) );
for (size_t i=0; i<map->getNodeNumElements(); ++i) {
op->insertGlobalValues(map->getGlobalElement(i),tuple(map->getGlobalElement(i)), tuple(ScalarTraits<Scalar>::one()));
}
Expand Down
2 changes: 1 addition & 1 deletion packages/belos/tpetra/test/FixedPoint/test_fp_hb.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -217,7 +217,7 @@ int main(int argc, char *argv[]) {
int NumMyElements = diagonal.getMap()->getNodeNumElements();
auto MyGlobalElements = diagonal.getMap()->getNodeElementList();
Teuchos::ArrayRCP<ST> dd=diagonal.getDataNonConst();
RCP<CrsMatrix<ST> > invDiagMatrix = Teuchos::rcp(new CrsMatrix<ST>(A->getRowMap(), 1, Tpetra::StaticProfile));
RCP<CrsMatrix<ST> > invDiagMatrix = Teuchos::rcp(new CrsMatrix<ST>(A->getRowMap(), 1));

for (Teuchos_Ordinal i=0; i<NumMyElements; ++i) {
invDiagMatrix->insertGlobalValues(MyGlobalElements[i],
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -112,7 +112,7 @@ createTestMatrix (Teuchos::FancyOStream& out,
// lets us use local indices.
RCP<const map_type> colMap = rowMap;
const size_t maxNumEntPerRow = 1;
RCP<MAT> A (new MAT (rowMap, colMap, maxNumEntPerRow, Tpetra::StaticProfile));
RCP<MAT> A (new MAT (rowMap, colMap, maxNumEntPerRow));

if (rowMap->getNodeNumElements () != 0) {
Teuchos::Array<SC> vals (1);
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -86,7 +86,7 @@ createTestMatrix (Teuchos::FancyOStream& out,
// lets us use local indices.
RCP<const map_type> colMap = rowMap;
const size_t maxNumEntPerRow = 1;
RCP<MAT> A (new MAT (rowMap, colMap, maxNumEntPerRow, Tpetra::StaticProfile));
RCP<MAT> A (new MAT (rowMap, colMap, maxNumEntPerRow));

if (rowMap->getNodeNumElements () != 0) {
Teuchos::Array<SC> vals (1);
Expand Down
2 changes: 1 addition & 1 deletion packages/belos/tpetra/test/MVOPTester/cxx_main_complex.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -105,7 +105,7 @@ namespace {
template<class Scalar, class O1, class O2>
RCP<CrsMatrix<Scalar,O1,O2,Node> > constructDiagMatrix(const RCP<const Map<O1,O2,Node> > &map)
{
RCP<CrsMatrix<Scalar,O1,O2,Node> > op = rcp( new CrsMatrix<Scalar,O1,O2,Node>(map,1,Tpetra::StaticProfile) );
RCP<CrsMatrix<Scalar,O1,O2,Node> > op = rcp( new CrsMatrix<Scalar,O1,O2,Node>(map,1) );
for (size_t i=0; i<map->getNodeNumElements(); ++i) {
op->insertGlobalValues(map->getGlobalElement(i),tuple(map->getGlobalElement(i)), tuple(ScalarTraits<Scalar>::one()));
}
Expand Down
2 changes: 1 addition & 1 deletion packages/belos/tpetra/test/Native/nonsymm_matrix.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -97,7 +97,7 @@ createNonsymmTridiagMatrix (const Teuchos::RCP<const Tpetra::Map<> >& rowMap,
LO (rowMap->getNodeNumElements ());
const GO gblMinGblInd = rowMap->getMinAllGlobalIndex ();
const GO gblMaxGblInd = rowMap->getMaxAllGlobalIndex ();
auto A = rcp (new crs_matrix_type (rowMap, 3, Tpetra::StaticProfile));
auto A = rcp (new crs_matrix_type (rowMap, 3));

const SC ONE = STS::one ();
const SC TWO = ONE + ONE;
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -347,7 +347,7 @@ def config_script(self):
"""
Returns the configuration script name
This arbitrary name will be used for all runs until an override is established
This arbitrary name will be used for all runs until an override is established
Returns:
String containing the job-specific configuration script to load.
Expand Down
16 changes: 9 additions & 7 deletions packages/ifpack2/example/RelaxationWithEquilibration.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -380,17 +380,20 @@ tpetraToEpetraCrsMatrix (const Tpetra::CrsMatrix<double, LO, GO, NT>& A_t,
// We can use static profile, since we know the structure in advance.
Epetra_CrsMatrix A_e (Copy, rowMap, colMap, numEntPerRow.data (), true);

Teuchos::Array<LO> lclColIndsBuf (A_t.getNodeMaxNumRowEntries ());
Teuchos::Array<double> valsBuf (A_t.getNodeMaxNumRowEntries ());
using tmatrix_t = Tpetra::CrsMatrix<double, LO, GO, NT>;

typename tmatrix_t::nonconst_local_inds_host_view_type
lclColInds ("ifpack2::lclColInds", A_t.getNodeMaxNumRowEntries());
typename tmatrix_t::nonconst_values_host_view_type
vals ("ifpack2::vals", A_t.getNodeMaxNumRowEntries());

int lclErrCode = 0;
for (LO lclRow = 0; lclRow < lclNumRows; ++lclRow) {
size_t numEnt = A_t.getNumEntriesInLocalRow (lclRow);
Teuchos::ArrayView<LO> lclColInds = lclColIndsBuf (0, numEnt);
Teuchos::ArrayView<double> vals = valsBuf (0, numEnt);

A_t.getLocalRowCopy (static_cast<LO> (lclRow), lclColInds, vals, numEnt);
lclErrCode = A_e.InsertMyValues (lclRow, static_cast<int> (numEnt),
vals.getRawPtr (), lclColInds.getRawPtr ());
vals.data(), lclColInds.data());
if (lclErrCode != 0) {
break;
}
Expand Down Expand Up @@ -880,8 +883,7 @@ gatherCrsMatrixAndMultiVector (LO& errCode,
export_type exp (A.getRowMap (), rowMap_gathered);
auto A_gathered =
Teuchos::rcp (new crs_matrix_type (rowMap_gathered,
A.getGlobalMaxNumRowEntries (),
Tpetra::StaticProfile));
A.getGlobalMaxNumRowEntries ()));
A_gathered->doExport (A, exp, Tpetra::INSERT);
auto domainMap_gathered = computeGatherMap (A.getDomainMap (), Teuchos::null);
auto rangeMap_gathered = computeGatherMap (A.getRangeMap (), Teuchos::null);
Expand Down
4 changes: 2 additions & 2 deletions packages/ifpack2/src/Ifpack2_ILUT_def.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -716,7 +716,7 @@ void ILUT<MatrixType>::compute ()
}

L_ = rcp (new crs_matrix_type (A_local_->getRowMap(), A_local_->getColMap(),
nnzPerRow(), Tpetra::StaticProfile));
nnzPerRow()));

for (local_ordinal_type row_i = 0 ; row_i < myNumRows ; ++row_i) {
L_->insertLocalValues (row_i, L_tmp_idx[row_i](), L_tmpv[row_i]());
Expand All @@ -729,7 +729,7 @@ void ILUT<MatrixType>::compute ()
}

U_ = rcp (new crs_matrix_type (A_local_->getRowMap(), A_local_->getColMap(),
nnzPerRow(), Tpetra::StaticProfile));
nnzPerRow()));

for (local_ordinal_type row_i = 0 ; row_i < myNumRows ; ++row_i) {
U_->insertLocalValues (row_i, U_tmp_idx[row_i](), U_tmpv[row_i]());
Expand Down
4 changes: 2 additions & 2 deletions packages/ifpack2/src/Ifpack2_SparseContainer_def.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -553,7 +553,7 @@ extract ()
}
//now that row sizes are known, can allocate the diagonal matrix
RCP<InverseMap> tempMap(new InverseMap(blockPointSize, 0, this->localComm_));
diagBlocks_[i] = rcp(new InverseCrs(tempMap, rowEntryCounts, Tpetra::StaticProfile));
diagBlocks_[i] = rcp(new InverseCrs(tempMap, rowEntryCounts));
Inverses_[i] = rcp(new InverseType(diagBlocks_[i]));
//insert the actual entries, one row at a time
for(LO blockRow = 0; blockRow < blockSize; blockRow++)
Expand Down Expand Up @@ -617,7 +617,7 @@ extract ()
rowEntryCounts[j] = this->getInputRowView(this->blockRows_[blockStart + j]).size();
}
RCP<InverseMap> tempMap(new InverseMap(blockSize, 0, this->localComm_));
diagBlocks_[i] = rcp(new InverseCrs(tempMap, rowEntryCounts, Tpetra::StaticProfile));
diagBlocks_[i] = rcp(new InverseCrs(tempMap, rowEntryCounts));
Inverses_[i] = rcp(new InverseType(diagBlocks_[i]));
for(LO blockRow = 0; blockRow < blockSize; blockRow++)
{
Expand Down
2 changes: 1 addition & 1 deletion packages/ifpack2/src/Ifpack2_Utilities.hpp
Original file line number Diff line number Diff line change
Expand Up @@ -79,7 +79,7 @@ namespace Details {
// make sure that we are using the correct diagonal column
// indices, so it probably wouldn't help much.
Teuchos::RCP<graph_type> diagonalGraph;
diagonalGraph = Teuchos::rcp(new crs_graph_type(graph.getRowMap(), maxDiagEntPerRow, Tpetra::StaticProfile));
diagonalGraph = Teuchos::rcp(new crs_graph_type(graph.getRowMap(), maxDiagEntPerRow));
const map_type& meshRowMap = *(graph.getRowMap());

Teuchos::Array<GO> diagGblColInds(maxDiagEntPerRow);
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -473,7 +473,7 @@ SupportGraph<MatrixType>::findSupport ()
// Create the CrsMatrix for the support graph
Support_ = rcp (new crs_matrix_type (A_local_->getRowMap(),
A_local_->getColMap(),
localnumnz, Tpetra::StaticProfile));
localnumnz));

// Fill in the matrix with the stl vectors for each row
for (size_t row = 0; row < num_verts; ++row) {
Expand Down
2 changes: 1 addition & 1 deletion packages/ifpack2/test/unit_tests/Ifpack2_SolverFactory.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -73,7 +73,7 @@ namespace {
// lets us use local indices.
RCP<const map_type> colMap = rowMap;
const size_t maxNumEntPerRow = 1;
RCP<MAT> A (new MAT (rowMap, colMap, maxNumEntPerRow, Tpetra::StaticProfile));
RCP<MAT> A (new MAT (rowMap, colMap, maxNumEntPerRow));

if (rowMap->getNodeNumElements () != 0) {
Teuchos::Array<SC> vals (1);
Expand Down
3 changes: 1 addition & 2 deletions packages/ifpack2/test/unit_tests/Ifpack2_UnitTest234.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -119,8 +119,7 @@ TEUCHOS_UNIT_TEST_TEMPLATE_1_DECL(Chebyshev, Issue234, SC)
// For a diagonal matrix, we can use the row Map as the column Map.
const size_t maxNumEntPerRow = 1;
RCP<crs_matrix_type> A =
rcp (new crs_matrix_type (rowMap, colMap, maxNumEntPerRow,
Tpetra::StaticProfile));
rcp (new crs_matrix_type (rowMap, colMap, maxNumEntPerRow));
for (LO lclRow = 0; lclRow < lclNumRows; ++lclRow) {
A->insertLocalValues (lclRow, tuple (lclRow), tuple (ONE));
}
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -379,7 +379,7 @@ TEUCHOS_UNIT_TEST(Ifpack2Chebyshev, Convergence)
RCP<const map_type> domainMap = rowMap;

// Create the matrix, with static profile.
RCP<crs_matrix_type> A (new crs_matrix_type (rowMap, 3, Tpetra::StaticProfile));
RCP<crs_matrix_type> A (new crs_matrix_type (rowMap, 3));

// Fill the matrix.
Array<GO> cols (3);
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -105,7 +105,7 @@ TEUCHOS_UNIT_TEST_TEMPLATE_3_DECL(ContainerFactory, TestTypesAndInput, SC, LO, G

// For a diagonal matrix, we can use the row Map as the column Map.
const size_t maxNumEntPerRow = 1;
RCP<crs_matrix_type> A = rcp (new crs_matrix_type (rowMap, colMap, maxNumEntPerRow, Tpetra::StaticProfile));
RCP<crs_matrix_type> A = rcp (new crs_matrix_type (rowMap, colMap, maxNumEntPerRow));
for (LO lclRow = 0; lclRow < lclNumRows; ++lclRow) {
A->insertLocalValues (lclRow, tuple (lclRow), tuple (ONE));
}
Expand Down
Loading

0 comments on commit 3f8d0b6

Please sign in to comment.